Tpetra parallel linear algebra Version of the Day
Loading...
Searching...
No Matches
Namespace List
Here is a list of all documented namespaces with brief descriptions:
[detail level 1234]
 NDetailsImplementation details of Tpetra
 NMatrixMarketMatrix Market file readers and writers for sparse and dense matrices (as CrsMatrix resp. MultiVector)
 NSortDetailsImplementation details of sort routines used by Tpetra
 NTpetraNamespace Tpetra contains the class and methods constituting the Tpetra library
 NDetailsNonmember function that computes a residual Computes R = B - A * X
 NDefaultTypesDeclarations of values of Tpetra classes' default template parameters
 CCommBufferMemorySpaceMemory space used for MPI communication buffers
 CAbsMaxFunctor for the the ABSMAX CombineMode of Import and Export operations
 CBehaviorDescription of Tpetra's behavior
 CCommRequestBase class for the request (more or less a future) representing a pending nonblocking MPI operation
 CContiguousUniformDirectoryImplementation of Directory for a contiguous, uniformly distributed Map
 CCooMatrixSparse matrix used only for file input / output
 CCrsMatrixGetDiagCopyFunctorFunctor that implements much of the one-argument overload of Tpetra::CrsMatrix::getLocalDiagCopy, for the case where the matrix is fill complete
 CCrsPaddingKeep track of how much more space a CrsGraph or CrsMatrix needs, when the graph or matrix is the target of a doExport or doImport
 CDeepCopyCounterCounter for Kokkos::deep_copy's between memory spaces
 CDirectoryComputes the local ID and process ID corresponding to given global IDs
 CDistributedContiguousDirectoryImplementation of Directory for a distributed contiguous Map
 CDistributedNoncontiguousDirectoryImplementation of Directory for a distributed noncontiguous Map
 CDistributorPlan
 CEquilibrationInfoStruct storing results of Tpetra::computeRowAndColumnOneNorms
 CFixedHashTable
 CHashThe hash function for FixedHashTable
 CHash< KeyType, DeviceType, OffsetType, int >Specialization for ResultType = int
 CHashTable
 CInvalidGlobalIndexException thrown by CrsMatrix on invalid global index
 CInvalidGlobalRowIndexException thrown by CrsMatrix on invalid global row index
 CLeftScaleLocalCrsMatrixKokkos::parallel_for functor that left-scales a KokkosSparse::CrsMatrix
 CLocalMap"Local" part of Map suitable for Kokkos kernels
 CLocalResidualFunctorFunctor for computing the residual
 CLocalTriangularStructureResultReturn value of determineLocalTriangularStructure
 COffRankUpdateFunctorFunctor for computing R -= A_offRank*X_colmap
 COptColMapImplementation detail of makeOptimizedColMap, and makeOptimizedColMapAndImport
 CPackTraitsTraits class for packing / unpacking data of type T
 CProfilingRegionProfile the given scope
 CReplicatedDirectoryImplementation of Directory for a locally replicated Map
 CRightScaleLocalCrsMatrixKokkos::parallel_for functor that right-scales a KokkosSparse::CrsMatrix
 CScalarViewTraitsTraits class for allocating a Kokkos::View<T*, D>
 CTieBreakInterface for breaking ties in ownership
 CTripletRepresentation of a global index on a process
 CTransferCommon base class of Import and Export
 NExtNamespace for external Tpetra functionality
 NImplNamespace for new Tpetra features that are not ready for public release, but are ready for evaluation by friendly expert users
 CAbsMaxImplementation 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
 CAXPYImplementation 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)
 CCOPYImplementation 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)
 CFILLImplementation 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)
 CGETRSComputes 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
 CSCALImplementation 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)
 NMatrixMatrixDistributed sparse matrix-matrix multiply and add
 NTripleMatrixMultiplyDistributed sparse triple matrix product
 CBlockCrsMatrixSparse matrix whose entries are small dense square blocks, all of the same dimensions
 CBlockCrsMatrixStructStruct that holds views of the contents of a BlockCrsMatrix
 CBlockCrsMatrixTransposerConstruct and (optionally) redistribute the explicitly stored transpose of a BlockCrsMatrix
 CBlockMultiVectorMultiVector for multiple degrees of freedom per mesh point
 CBlockVectorVector for multiple degrees of freedom per mesh point
 CCrsGraphA distributed graph accessed by rows (adjacency lists) and stored sparsely
 CCrsGraphTransposerConstruct and (optionally) redistribute the explicitly stored transpose of a CrsGraph
 CCrsMatrixSparse matrix that presents a row-oriented interface that lets users read or modify entries
 CCrsMatrixMultiplyOpA class for wrapping a CrsMatrix multiply in a Operator
 CCrsMatrixStructStruct that holds views of the contents of a CrsMatrix
 CDirectoryImplement mapping from global ID to process ID and local ID
 CDistObjectBase class for distributed Tpetra objects that support data redistribution
 CDistributorSets up and executes a communication plan for a Tpetra DistObject
 CExportCommunication plan for data redistribution from a (possibly) multiply-owned to a uniquely-owned distribution
 CFECrsGraphA distributed graph accessed by rows (adjacency lists) and stored sparsely
 CImportCommunication plan for data redistribution from a uniquely-owned to a (possibly) multiply-owned distribution
 CImportExportDataImplementation detail of Import and Export
 CLocalCrsMatrixOperatorAbstract interface for local operators (e.g., matrices and preconditioners)
 CLocalOperatorAbstract interface for local operators (e.g., matrices and preconditioners)
 CMapA parallel distribution of indices over processes
 CMixedScalarMultiplyOpA class for wrapping an Operator of one Scalar type into an Operator of another Scalar type
 CMultiVectorOne or more distributed dense vectors
 COperatorAbstract interface for operators (e.g., matrices and preconditioners)
 CPackableAbstract 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
 Cproject1stBinary function that returns its first argument
 Cproject2ndBinary function that returns its second argument
 CRowGraphAn abstract interface for graphs accessed by rows
 CRowInfoAllocation information for a locally owned row in a CrsGraph or CrsMatrix
 CRowMatrixA read-only, row-oriented interface to a sparse matrix
 CRowMatrixTransposerConstruct and (optionally) redistribute the explicitly stored transpose of a CrsMatrix
 CScopeGuardScope guard whose destructor automatically calls Tpetra::finalize for you
 CSrcDistObjectAbstract base class for objects that can be the source of an Import or Export operation
 CVectorA distributed dense vector
 NTpetraExamplesNamespace for Tpetra example classes and methods