▼NKokkos | |
CDeviceGEMM | Class that provides GEMM for a particular Kokkos Device |
▼NTpetra | Namespace Tpetra contains the class and methods constituting the Tpetra library |
▼NDetails | Namespace for Tpetra implementation details |
▶NFHT | |
CCheckForDuplicateKeys | Functor for checking whether a FixedHashTable has one or more duplicate entries |
CCountBuckets | Parallel for functor for counting "buckets" in the FixedHashTable |
CFillPairs | Parallel reduce functor for filling the FixedHashTable, and computing the min and max keys |
CFillPairsResult | Reduction result for FillPairs functor below |
▶NImpl | |
CGetGraphDiagOffsets | Implementation detail of Tpetra::Details::getGraphDiagOffsets, which in turn is an implementation detail of Tpetra::CrsGraph |
CAbsMax | Functor for the the ABSMAX CombineMode of Import and Export operations |
CContiguousUniformDirectory | Implementation of Directory for a contiguous, uniformly distributed Map |
CCrsMatrixGetDiagCopyFunctor | Functor that implements much of the one-argument overload of Tpetra::CrsMatrix::getLocalDiagCopy, for the case where the matrix is fill complete |
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 |
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 |
CLocalMap | "Local" part of Map suitable for Kokkos kernels |
CMapCloner | Implementation detail of Map::clone() |
CMultiVectorCloner | Implementation of Tpetra::MultiVector::clone() |
CMultiVectorFillerData | Implementation of fill and local assembly for MultiVectorFiller |
CMultiVectorFillerData2 | Second implementation of fill and local assembly for MultiVectorFiller |
COptColMap | Implementation detail of makeOptimizedColMap, and makeOptimizedColMapAndImport |
COrdinalTraits | Traits class for "invalid" (flag) values of integer types that Tpetra uses as local ordinals or global ordinals |
CPackTraits | Traits class for packing / unpacking data of type T , using Kokkos data structures that live in the given space D |
CReplicatedDirectory | Implementation of Directory for a locally replicated Map |
▶CTieBreak | Interface for breaking ties in ownership |
CTriplet | Representation of a global index on a process |
CTransfer | Common base class of Import and Export |
▼Ndetails | |
CApplyOp | A class for wrapping an Operator apply in a Operator |
▼NExperimental | Namespace for new Tpetra features that are not ready for public release, but are ready for evaluation by friendly expert users |
▶NImpl | |
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::Experimental::AXPY function |
CAXPY< CoefficientType, ViewType1, ViewType2, Kokkos::LayoutLeft, Kokkos::LayoutLeft, IndexType, 2 > | Implementation of Tpetra::Experimental::AXPY function, for ViewType1 and ViewType2 rank 2 (i.e., matrices), when both ViewType1 and ViewType2 have LayoutLeft |
CAXPY< CoefficientType, ViewType1, ViewType2, Kokkos::LayoutRight, Kokkos::LayoutRight, IndexType, 2 > | Implementation of Tpetra::Experimental::AXPY function, for ViewType1 and ViewType2 rank 2 (i.e., matrices), when both ViewType1 and ViewType2 have LayoutRight |
CAXPY< CoefficientType, ViewType1, ViewType2, LayoutType1, LayoutType2, IndexType, 1 > | Implementation of Tpetra::Experimental::AXPY function, for ViewType1 and ViewType2 rank 1 (i.e., vectors) |
CAXPY< CoefficientType, ViewType1, ViewType2, LayoutType1, LayoutType2, IndexType, 2 > | Implementation of Tpetra::Experimental::AXPY function, for ViewType1 and ViewType2 rank 2 (i.e., matrices) |
CCOPY | Implementation of Tpetra::Experimental::COPY function |
CCOPY< ViewType1, ViewType2, Kokkos::LayoutLeft, Kokkos::LayoutLeft, IndexType, 2 > | Implementation of Tpetra::Experimental::COPY function, for ViewType1 and ViewType2 rank 2 (i.e., matrices), where both have LayoutLeft (row-major order, with contiguous storage) |
CCOPY< ViewType1, ViewType2, Kokkos::LayoutRight, Kokkos::LayoutRight, IndexType, 2 > | Implementation of Tpetra::Experimental::COPY function, for ViewType1 and ViewType2 rank 2 (i.e., matrices), where both have LayoutRight (row-major order, with contiguous storage) |
CCOPY< ViewType1, ViewType2, LayoutType1, LayoutType2, IndexType, 1 > | Implementation of Tpetra::Experimental::COPY function, for ViewType1 and ViewType2 rank 1 (i.e., vectors) |
CCOPY< ViewType1, ViewType2, LayoutType1, LayoutType2, IndexType, 2 > | Implementation of Tpetra::Experimental::COPY function, for ViewType1 and ViewType2 rank 2 (i.e., matrices) |
CFILL | Implementation of Tpetra::Experimental::FILL function |
CFILL< ViewType, InputType, LayoutType, IndexType, 1 > | Implementation of Tpetra::Experimental::FILL function, for ViewType rank 1 (i.e., a vector) |
CFILL< ViewType, InputType, LayoutType, IndexType, 2 > | Implementation of Tpetra::Experimental::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::Experimental::SCAL function |
CSCAL< ViewType, CoefficientType, Kokkos::LayoutRight, IndexType, 2 > | Implementation of Tpetra::Experimental::SCAL function, for ViewType rank 2 (i.e., a matrix), and LayoutType = LayoutRight |
CSCAL< ViewType, CoefficientType, LayoutType, IndexType, 1 > | Implementation of Tpetra::Experimental::SCAL function, for ViewType rank 1 (i.e., a vector) |
CSCAL< ViewType, CoefficientType, LayoutType, IndexType, 2 > | Implementation of Tpetra::Experimental::SCAL function, for ViewType rank 2 (i.e., a matrix) |
CBlockCrsMatrix | Sparse matrix whose entries are small dense square blocks, all of the same dimensions |
CBlockMultiVector | MultiVector for multiple degrees of freedom per mesh point |
CBlockVector | Vector for multiple degrees of freedom per mesh point |
▼NExt | Namespace for external Tpetra functionality |
CTypeStack | Implementation of a Tpetra::Ext::TypeStack, supporting the next to last entry |
CTypeStack< T, TypeStack< S, SS > > | Generic implementation of a Tpetra::Ext::TypeStack. This is the model that should be programmed to |
CTypeStackBottom | Implementation of a Tpetra::Ext::TypeStack, supporting the last entry |
▼NKokkosRefactor | |
▶NDetails | |
▶NImpl | Implementation details of implementation details |
COutOfBounds | Is x out of bounds? That is, is x less than zero, or greater than or equal to the given exclusive upper bound? |
▼NMatrixMarket | |
CReader | Matrix Market file reader for CrsMatrix and MultiVector |
CWriter | Matrix Market file writer for CrsMatrix and MultiVector |
▼NRTI | Namespace for Tpetra Reduction/Tranformation Interface |
▶Ndetail | Internal detail for Tpetra::RTI. Methods and class here are not guaranteed to be backwards compatible |
CBinaryFunctorAdapter | Adapter class between kernels for Tpetra::RTI::binary_transform and Tpetra::RTI::detail::binary_transform |
CBinaryFunctorAdapterWithAlphaBeta | Adapter class between binary functors and BinaryOp |
CRTIPreTransformReductionAdapter | Adapter class between kernels for Tpetra::RTI::binary_pre_transform_reduce and Tpetra::RTI::detail::binary_transform |
CRTIPreTransformReductionAdapter3 | Adapter class between kernels for Tpetra::RTI::binary_pre_transform_reduce and Tpetra::RTI::detail::binary_transform |
CRTIReductionAdapter1 | Adapter class between kernels for Tpetra::RTI::binary_transform and Tpetra::RTI::detail::binary_transform |
CRTIReductionAdapter2 | Adapter class between kernels for Tpetra::RTI::binary_transform and Tpetra::RTI::detail::binary_transform |
CRTIReductionAdapter3 | Adapter class between kernels for Tpetra::RTI::binary_transform and Tpetra::RTI::detail::binary_transform for three vectors |
CStdOpKernel | Utility base class for kernels used to define Tpetra::Operator objects |
CTertiaryFunctorAdapter | Adapter class between kernels for Tpetra::RTI::tertiary_transform and Tpetra::RTI::detail::tertiary_transform |
CTeuchosValueTypeReductionOpAdapter | Decorator for Kokkos reduction kernels to satisfy requirements for Teuchos::ValueTypeReductionOp |
CUnaryFunctorAdapter | Adapter class between kernels for Tpetra::RTI::unary_transform and Tpetra::RTI::detail::unary_transform |
CBinaryOp | Tpetra::Operator wrapping a binary functor using the Tpetra Reduction/Transformation Interface |
CKernelOp | Operator wrapping a Kokkos (Classic) kernel using RTI |
COneOp | A static identity functor, providing a static method identity() that returns one |
CReductionGlob | A type glob containing the types needed for calling Tpetra::RTI::reduce() with individual functors |
CTransformReductionGlob | A type glob containing the types needed for calling Tpetra::RTI::binary_pre_transform_reduce() with individual functors |
CZeroOp | A static identity functor, providing a static method identity() that returns zero |
▼NTest | |
CMultiVectorFillerTester | Tests for MultiVectorFiller |
CCrsGraph | A distributed graph accessed by rows (adjacency lists) and stored sparsely |
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 |
CCrsMatrixSolveOp | Wrap a CrsMatrix instance's triangular solve in an Operator |
CCrsMatrixStruct | Struct that holds views of the contents of a CrsMatrix |
CDefaultPlatform | Returns a default platform appropriate for the enviroment |
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 |
CImport | Communication plan for data redistribution from a uniquely-owned to a (possibly) multiply-owned distribution |
CImportExportData | Implementation detail of Import and Export |
CMap | Describes a parallel distribution of objects over processes |
CMpiPlatform | Implementation of the Platform concept for MPI-based platforms |
CMpiPlatform< ::Tpetra::Details::DefaultTypes::node_type > | MpiPlatform specialization for the default Node type |
CMultiVector | One or more distributed dense vectors |
CMultiVectorFiller | Adds nonlocal sum-into functionality to Tpetra::MultiVector |
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 |
CSerialPlatform | Implementation of the Platform concept for non-MPI platforms |
CSerialPlatform< Tpetra::Details::DefaultTypes::node_type > | SerialPlatform specialization for the default Node type |
CSrcDistObject | Abstract base class for objects that can be the source of an Import or Export operation |
CVector | A distributed dense vector |