NDetails | Implementation details of Tpetra |
NMatrixMarket | Matrix Market file readers and writers for sparse and dense matrices (as CrsMatrix resp. MultiVector ) |
NSortDetails | Implementation details of sort routines used by Tpetra |
▼NTpetra | Namespace Tpetra contains the class and methods constituting the Tpetra library |
▼NDetails | Nonmember function that computes a residual Computes R = B - A * X |
▼NDefaultTypes | Declarations of values of Tpetra classes' default template parameters |
CCommBufferMemorySpace | Memory space used for MPI communication buffers |
CAbsMax | Functor for the the ABSMAX CombineMode of Import and Export operations |
CBehavior | Description of Tpetra's behavior |
CCommRequest | Base class for the request (more or less a future) representing a pending nonblocking MPI operation |
CContiguousUniformDirectory | Implementation of Directory for a contiguous, uniformly distributed Map |
CCooMatrix | Sparse matrix used only for file input / output |
CCrsMatrixGetDiagCopyFunctor | Functor that implements much of the one-argument overload of Tpetra::CrsMatrix::getLocalDiagCopy, for the case where the matrix is fill complete |
CCrsPadding | Keep track of how much more space a CrsGraph or CrsMatrix needs, when the graph or matrix is the target of a doExport or doImport |
CDeepCopyCounter | Counter for Kokkos::deep_copy's between memory spaces |
CDirectory | Computes the local ID and process ID corresponding to given global IDs |
CDistributedContiguousDirectory | Implementation of Directory for a distributed contiguous Map |
CDistributedNoncontiguousDirectory | Implementation of Directory for a distributed noncontiguous Map |
CDistributorPlan | |
CEquilibrationInfo | Struct storing results of Tpetra::computeRowAndColumnOneNorms |
CFixedHashTable | |
CHash | The hash function for FixedHashTable |
CHash< KeyType, DeviceType, OffsetType, int > | Specialization for ResultType = int |
CHashTable | |
CInvalidGlobalIndex | Exception thrown by CrsMatrix on invalid global index |
CInvalidGlobalRowIndex | Exception thrown by CrsMatrix on invalid global row index |
CLeftScaleLocalCrsMatrix | Kokkos::parallel_for functor that left-scales a KokkosSparse::CrsMatrix |
CLocalMap | "Local" part of Map suitable for Kokkos kernels |
CLocalResidualFunctor | Functor for computing the residual |
CLocalTriangularStructureResult | Return value of determineLocalTriangularStructure |
COffRankUpdateFunctor | Functor for computing R -= A_offRank*X_colmap |
COptColMap | Implementation detail of makeOptimizedColMap, and makeOptimizedColMapAndImport |
CPackTraits | Traits class for packing / unpacking data of type T |
CProfilingRegion | Profile the given scope |
CReplicatedDirectory | Implementation of Directory for a locally replicated Map |
CRightScaleLocalCrsMatrix | Kokkos::parallel_for functor that right-scales a KokkosSparse::CrsMatrix |
CScalarViewTraits | Traits class for allocating a Kokkos::View<T*, D> |
▼CTieBreak | Interface for breaking ties in ownership |
CTriplet | Representation of a global index on a process |
CTransfer | Common base class of Import and Export |
NExt | Namespace for external Tpetra functionality |
▼NImpl | Namespace for new Tpetra features that are not ready for public release, but are ready for evaluation by friendly expert users |
CAbsMax | Implementation of Tpetra's ABSMAX CombineMode for the small dense blocks in BlockCrsMatrix, or the small dense vectors in BlockMultiVector and BlockVector |
CAbsMax< ViewType1, ViewType2, 1 > | Implementation of Tpetra's ABSMAX CombineMode for the small dense vectors in BlockMultiVector and BlockVector |
CAbsMax< ViewType1, ViewType2, 2 > | Implementation of Tpetra's ABSMAX CombineMode for the small dense blocks in BlockCrsMatrix |
CAXPY | Implementation of Tpetra::AXPY function |
CAXPY< CoefficientType, ViewType1, ViewType2, IndexType, false, 1 > | Implementation of Tpetra::AXPY function, for ViewType1 and ViewType2 rank 1 (i.e., vectors) |
CAXPY< CoefficientType, ViewType1, ViewType2, IndexType, false, 2 > | Implementation of Tpetra::AXPY function, for ViewType1 and ViewType2 rank 2 (i.e., matrices) |
CCOPY | Implementation of Tpetra::COPY function |
CCOPY< ViewType1, ViewType2, IndexType, false, 1 > | Implementation of Tpetra::COPY function, for ViewType1 and ViewType2 rank 1 (i.e., vectors) |
CCOPY< ViewType1, ViewType2, IndexType, false, 2 > | Implementation of Tpetra::COPY function, for ViewType1 and ViewType2 rank 2 (i.e., matrices) |
CFILL | Implementation of Tpetra::FILL function |
CFILL< ViewType, InputType, IndexType, false, 1 > | Implementation of Tpetra::FILL function, for ViewType rank 1 (i.e., a vector) |
CFILL< ViewType, InputType, IndexType, false, 2 > | Implementation of Tpetra::FILL function, for ViewType rank 2 (i.e., a matrix) |
CGETRS | Computes the solution to Ax=b |
CGETRS< LittleBlockType, LittleIntVectorType, LittleScalarVectorType, 1 > | Special case of GETRS for a single right-hand side |
CGETRS< LittleBlockType, LittleIntVectorType, LittleScalarVectorType, 2 > | Special case of GETRS for multiple right-hand sides |
CSCAL | Implementation of Tpetra::SCAL function |
CSCAL< ViewType, CoefficientType, IndexType, false, 1 > | Implementation of Tpetra::SCAL function, for ViewType rank 1 (i.e., a vector) |
CSCAL< ViewType, CoefficientType, IndexType, false, 2 > | Implementation of Tpetra::SCAL function, for ViewType rank 2 (i.e., a matrix) |
NMatrixMatrix | Distributed sparse matrix-matrix multiply and add |
NTripleMatrixMultiply | Distributed sparse triple matrix product |
CBlockCrsMatrix | Sparse matrix whose entries are small dense square blocks, all of the same dimensions |
CBlockCrsMatrixStruct | Struct that holds views of the contents of a BlockCrsMatrix |
CBlockCrsMatrixTransposer | Construct and (optionally) redistribute the explicitly stored transpose of a BlockCrsMatrix |
CBlockMultiVector | MultiVector for multiple degrees of freedom per mesh point |
CBlockVector | Vector for multiple degrees of freedom per mesh point |
CCrsGraph | A distributed graph accessed by rows (adjacency lists) and stored sparsely |
CCrsGraphTransposer | Construct and (optionally) redistribute the explicitly stored transpose of a CrsGraph |
CCrsMatrix | Sparse matrix that presents a row-oriented interface that lets users read or modify entries |
CCrsMatrixMultiplyOp | A class for wrapping a CrsMatrix multiply in a Operator |
CCrsMatrixStruct | Struct that holds views of the contents of a CrsMatrix |
CDirectory | Implement mapping from global ID to process ID and local ID |
CDistObject | Base class for distributed Tpetra objects that support data redistribution |
CDistributor | Sets up and executes a communication plan for a Tpetra DistObject |
CExport | Communication plan for data redistribution from a (possibly) multiply-owned to a uniquely-owned distribution |
CFECrsGraph | A distributed graph accessed by rows (adjacency lists) and stored sparsely |
CImport | Communication plan for data redistribution from a uniquely-owned to a (possibly) multiply-owned distribution |
CImportExportData | Implementation detail of Import and Export |
CLocalCrsMatrixOperator | Abstract interface for local operators (e.g., matrices and preconditioners) |
CLocalOperator | Abstract interface for local operators (e.g., matrices and preconditioners) |
CMap | A parallel distribution of indices over processes |
CMixedScalarMultiplyOp | A class for wrapping an Operator of one Scalar type into an Operator of another Scalar type |
CMultiVector | One or more distributed dense vectors |
COperator | Abstract interface for operators (e.g., matrices and preconditioners) |
CPackable | Abstract base class for objects that can be the source of an Import or Export operation, and that also know how to pack their data to send to the target object |
Cproject1st | Binary function that returns its first argument |
Cproject2nd | Binary function that returns its second argument |
CRowGraph | An abstract interface for graphs accessed by rows |
CRowInfo | Allocation information for a locally owned row in a CrsGraph or CrsMatrix |
CRowMatrix | A read-only, row-oriented interface to a sparse matrix |
CRowMatrixTransposer | Construct and (optionally) redistribute the explicitly stored transpose of a CrsMatrix |
CScopeGuard | Scope guard whose destructor automatically calls Tpetra::finalize for you |
CSrcDistObject | Abstract base class for objects that can be the source of an Import or Export operation |
CVector | A distributed dense vector |
NTpetraExamples | Namespace for Tpetra example classes and methods |