Tpetra parallel linear algebra Version of the Day
Loading...
Searching...
No Matches
Class Hierarchy

Go to the graphical class hierarchy

This inheritance list is sorted roughly, but not completely, alphabetically:
[detail level 1234]
 CTpetra::Details::AbsMax< Scalar >Functor for the the ABSMAX CombineMode of Import and Export operations
 CTpetra::Impl::AbsMax< ViewType1, ViewType2, rank1 >Implementation of Tpetra's ABSMAX CombineMode for the small dense blocks in BlockCrsMatrix, or the small dense vectors in BlockMultiVector and BlockVector
 CTpetra::Impl::AbsMax< ViewType1, ViewType2, 1 >Implementation of Tpetra's ABSMAX CombineMode for the small dense vectors in BlockMultiVector and BlockVector
 CTpetra::Impl::AbsMax< ViewType1, ViewType2, 2 >Implementation of Tpetra's ABSMAX CombineMode for the small dense blocks in BlockCrsMatrix
 CTpetra::Impl::AXPY< CoefficientType, ViewType1, ViewType2, IndexType, is_contiguous, rank >Implementation of Tpetra::AXPY function
 CTpetra::Impl::AXPY< CoefficientType, ViewType1, ViewType2, IndexType, false, 1 >Implementation of Tpetra::AXPY function, for ViewType1 and ViewType2 rank 1 (i.e., vectors)
 CTpetra::Impl::AXPY< CoefficientType, ViewType1, ViewType2, IndexType, false, 2 >Implementation of Tpetra::AXPY function, for ViewType1 and ViewType2 rank 2 (i.e., matrices)
 CTpetra::Details::BehaviorDescription of Tpetra's behavior
 CTpetra::Details::Blas::BlasSupportsLayout< LayoutType >Do BLAS libraries (all that are compliant with the BLAS Standard) support the given Kokkos array layout?
 CTpetra::Details::Blas::BlasSupportsScalar< ScalarType >Do BLAS libraries (all that are compliant with the BLAS Standard) support the given "scalar" (matrix entry) type?
 CTpetra::BlockCrsMatrixStruct< Scalar, LocalOrdinal, GlobalOrdinal, Node >Struct that holds views of the contents of a BlockCrsMatrix
 CTpetra::BlockCrsMatrixTransposer< Scalar, LocalOrdinal, GlobalOrdinal, Node >Construct and (optionally) redistribute the explicitly stored transpose of a BlockCrsMatrix
 CTpetra::Details::FHT::CheckForDuplicateKeys< OffsetsViewType, PairsViewType, SizeType >Functor for checking whether a FixedHashTable has one or more duplicate entries
 CTpetra::Details::DefaultTypes::CommBufferMemorySpace< ExecutionSpace >Memory space used for MPI communication buffers
 CTpetra::Details::CommRequestBase class for the request (more or less a future) representing a pending nonblocking MPI operation
 CTpetra::Details::Impl::CompareCooGraphEntries< IndexType >Function comparing two CooGraphEntry structs, lexicographically, first by row index, then by column index
 CTpetra::Details::Impl::CooGraphEntry< IndexType >Type of each (row index, column index) pair in the Tpetra::Details::CooMatrix (see below)
 CTpetra::Details::Impl::CooMatrixImpl< SC, GO >Implementation detail of Tpetra::Details::CooMatrix (which see below)
 CTpetra::Details::Impl::CooMatrixImpl< SC, ::Tpetra::DistObject< char >::global_ordinal_type >
 CTpetra::Impl::COPY< ViewType1, ViewType2, IndexType, is_contiguous, rank >Implementation of Tpetra::COPY function
 CTpetra::Impl::COPY< ViewType1, ViewType2, IndexType, false, 1 >Implementation of Tpetra::COPY function, for ViewType1 and ViewType2 rank 1 (i.e., vectors)
 CTpetra::Impl::COPY< ViewType1, ViewType2, IndexType, false, 2 >Implementation of Tpetra::COPY function, for ViewType1 and ViewType2 rank 2 (i.e., matrices)
 CTpetra::Details::FHT::CountBuckets< CountsViewType, KeysViewType, SizeType >Parallel for functor for counting "buckets" in the FixedHashTable
 CTpetra::Details::Impl::CountLocalNumDiags< LocalGraphType, LocalMapType >Kokkos::parallel_reduce functor for counting the local number of diagonal entries in a sparse graph
 CTpetra::CrsGraphTransposer< LocalOrdinal, GlobalOrdinal, Node >Construct and (optionally) redistribute the explicitly stored transpose of a CrsGraph
 CTpetra::Details::CrsMatrixGetDiagCopyFunctor< DiagType, LocalMapType, CrsMatrixType >Functor that implements much of the one-argument overload of Tpetra::CrsMatrix::getLocalDiagCopy, for the case where the matrix is fill complete
 CTpetra::CrsMatrixStruct< Scalar, LocalOrdinal, GlobalOrdinal, Node >Struct that holds views of the contents of a CrsMatrix
 CTpetra::Details::CrsPadding< LocalOrdinal, GlobalOrdinal >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
 CTpetra::Details::DeepCopyCounterCounter for Kokkos::deep_copy's between memory spaces
 CTpetra::Details::Impl::DetermineLocalTriangularStructure< LocalGraphType, LocalMapType >Implementation of Tpetra::Details::determineLocalTriangularStructure (which see below)
 CTpetra::Details::Directory< LocalOrdinal, GlobalOrdinal, NodeType >Computes the local ID and process ID corresponding to given global IDs
 CTpetra::Directory< LocalOrdinal, GlobalOrdinal, Node >Implement mapping from global ID to process ID and local ID
 CTpetra::DistributorSets up and executes a communication plan for a Tpetra DistObject
 CTpetra::Details::DistributorPlan
 CTpetra::Details::EquilibrationInfo< ScalarType, DeviceType >Struct storing results of Tpetra::computeRowAndColumnOneNorms
 CTpetra::Details::EquilibrationInfo< val_type, typename NT::device_type >
 CTpetra::Details::Blas::Impl::Fill< ViewType, ValueType, ExecutionSpace, IndexType, rank >Implementation of Tpetra::Details::Blas::fill
 CTpetra::Impl::FILL< ViewType, InputType, IndexType, is_contiguous, rank >Implementation of Tpetra::FILL function
 CTpetra::Impl::FILL< ViewType, InputType, IndexType, false, 1 >Implementation of Tpetra::FILL function, for ViewType rank 1 (i.e., a vector)
 CTpetra::Impl::FILL< ViewType, InputType, IndexType, false, 2 >Implementation of Tpetra::FILL function, for ViewType rank 2 (i.e., a matrix)
 CTpetra::Details::Blas::Impl::Fill< ViewType, ValueType, ExecutionSpace, IndexType, 1 >Specialization for rank-1 Views
 CTpetra::Details::Blas::Impl::Fill< ViewType, ValueType, ExecutionSpace, IndexType, 2 >Specialization for rank-2 Views
 CTpetra::Details::FHT::FillPairs< PairsViewType, KeysViewType, CountsViewType, SizeType >Parallel reduce functor for filling the FixedHashTable, and computing the min and max keys
 CTpetra::Details::FHT::FillPairsResult< KeyType >Reduction result for FillPairs functor below
 CTpetra::Details::FixedHashTable< KeyType, ValueType, DeviceType >
 CTpetra::Details::FixedHashTable< global_ordinal_type, local_ordinal_type, Kokkos::HostSpace::device_type >
 CTpetra::Details::FixedHashTable< global_ordinal_type, local_ordinal_type, no_uvm_device_type >
 CTpetra::Details::FixedHashTable< GlobalOrdinal, LocalOrdinal, no_uvm_device_type >
 CTpetra::Details::FixedHashTable< GO, LO, no_uvm_device_type >
 CTpetra::Details::Impl::GetGraphDiagOffsets< LO, GO, DeviceType, DiagOffsetType >Implementation detail of Tpetra::Details::getGraphDiagOffsets, which in turn is an implementation detail of Tpetra::CrsGraph
 CTpetra::Details::Impl::GetGraphOffRankOffsets< LO, GO, DeviceType, OffsetType >Implementation detail of Tpetra::Details::getGraphOffRankOffsets, which in turn is an implementation detail of Tpetra::CrsGraph
 CTpetra::Details::Impl::GetLocalNumDiags< MatrixType >Implementation of Tpetra::Details::getLocalNumDiags (see below)
 CTpetra::Details::Impl::GetLocalNumDiags< ::Tpetra::CrsGraph< LO, GO, NT > >Specialization of GetLocalNumDiags for CrsGraph
 CTpetra::Details::Impl::GetLocalNumDiags< ::Tpetra::RowGraph< LO, GO, NT > >Specialization of GetLocalNumDiags for RowGraph
 CTpetra::Impl::GETRS< LittleBlockType, LittleIntVectorType, LittleScalarVectorType, rank >Computes the solution to Ax=b
 CTpetra::Impl::GETRS< LittleBlockType, LittleIntVectorType, LittleScalarVectorType, 1 >Special case of GETRS for a single right-hand side
 CTpetra::Impl::GETRS< LittleBlockType, LittleIntVectorType, LittleScalarVectorType, 2 >Special case of GETRS for multiple right-hand sides
 CTpetra::Details::Hash< KeyType, DeviceType, OffsetType, ResultType >The hash function for FixedHashTable
 CTpetra::Details::Hash< KeyType, DeviceType, OffsetType, int >Specialization for ResultType = int
 CTpetra::Details::HashTable< KeyType, ValueType >
 CTpetra::ImportExportData< LocalOrdinal, GlobalOrdinal, Node >Implementation detail of Import and Export
 CTpetra::Details::InvalidGlobalIndex< GlobalOrdinal >Exception thrown by CrsMatrix on invalid global index
 CTpetra::Details::LeftScaleLocalCrsMatrix< LocalSparseMatrixType, ScalingFactorsViewType, divide >Kokkos::parallel_for functor that left-scales a KokkosSparse::CrsMatrix
 CTpetra::Details::LocalMap< LocalOrdinal, GlobalOrdinal, DeviceType >"Local" part of Map suitable for Kokkos kernels
 CTpetra::Details::LocalMap< LO, GO, device_type >
 CTpetra::Details::LocalMap< LO, GO, DT >
 CTpetra::LocalOperator< Scalar, Device >Abstract interface for local operators (e.g., matrices and preconditioners)
 CTpetra::LocalOperator< MultiVectorScalar, Device >
 CTpetra::LocalOperator< Scalar, typename crs_matrix_type::device_type >
 CTpetra::Details::LocalResidualFunctor< AMatrix, MV, ConstMV, Offsets, is_MV, restrictedMode, skipOffRank >Functor for computing the residual
 CTpetra::Details::LocalTriangularStructureResult< LO >Return value of determineLocalTriangularStructure
 CTpetra::Map< LocalOrdinal, GlobalOrdinal, Node >A parallel distribution of indices over processes
 CTpetra::Map< LO, GO, Node >
 CTpetra::Map< LO, GO, node_type >
 CTpetra::Map< LO, GO, NT >
 CTpetra::Details::UnpackAndCombineCrsMatrixImpl::NumEntriesFunctor< LO, DT, BDT >Kokkos::parallel_reduce functor to determine the number of entries (to unpack) in a KokkosSparse::CrsMatrix to pack
 CTpetra::Details::PackCrsGraphImpl::NumPacketsAndOffsetsFunctor< OutputOffsetsViewType, CountsViewType, InputOffsetsViewType, InputLocalRowIndicesViewType, InputLocalRowPidsViewType, debug >Compute the number of packets and offsets for the pack procedure
 CTpetra::Details::PackCrsMatrixImpl::NumPacketsAndOffsetsFunctor< OutputOffsetsViewType, CountsViewType, InputOffsetsViewType, InputLocalRowIndicesViewType, InputLocalRowPidsViewType, debug >Compute the number of packets and offsets for the pack procedure
 CTpetra::Details::OffRankUpdateFunctor< AMatrix, MV, ConstMV, Offsets, is_MV >Functor for computing R -= A_offRank*X_colmap
 CTpetra::Operator< Scalar, LocalOrdinal, GlobalOrdinal, Node >Abstract interface for operators (e.g., matrices and preconditioners)
 CTpetra::Operator< ::Tpetra::Details::DefaultTypes::scalar_type, ::Tpetra::Details::DefaultTypes::local_ordinal_type, ::Tpetra::Details::DefaultTypes::global_ordinal_type, ::Tpetra::Details::DefaultTypes::node_type >
 CTpetra::Operator< SC, LO, GO, NT >
 CTpetra::Operator< Scalar, LO, GO, Node >
 CTpetra::Operator< Scalar, OperatorType::local_ordinal_type, OperatorType::global_ordinal_type, OperatorType::node_type >
 CTpetra::Operator< scalar_t, Tpetra::Map<>::local_ordinal_type, Tpetra::Map<>::global_ordinal_type, ::Tpetra::Details::DefaultTypes::node_type >
 CTpetra::Details::OptColMap< MapType >Implementation detail of makeOptimizedColMap, and makeOptimizedColMapAndImport
 CTpetra::KokkosRefactor::Details::Impl::OutOfBounds< IntegerType, isSigned >Is x out of bounds? That is, is x less than zero, or greater than or equal to the given exclusive upper bound?
 CTpetra::Packable< Packet, LocalOrdinal >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
 CTpetra::Packable< char, ::Tpetra::Details::DefaultTypes::local_ordinal_type >
 CTpetra::Packable< char, LO >
 CTpetra::Packable< char, LocalOrdinal >
 CTpetra::Packable< GlobalOrdinal, LocalOrdinal >
 CTpetra::Packable< GO, LO >
 CTpetra::Details::PackTraits< T >Traits class for packing / unpacking data of type T
 CTpetra::Details::PackTraits< int >
 CTpetra::Details::PackTraits< LO >
 CTpetra::Details::ProfilingRegionProfile the given scope
 CTpetra::project1st< Arg1, Arg2 >Binary function that returns its first argument
 CTpetra::project2nd< Arg1, Arg2 >Binary function that returns its second argument
 CTpetra::MatrixMarket::Reader< SparseMatrixType >Matrix Market file reader for CrsMatrix and MultiVector
 CTpetra::Details::Impl::ReadLine< SC, GO, isComplex >Implementation of the readLine stand-alone function in this namespace (see below)
 CTpetra::Details::Impl::ReadLine< SC, GO, false >Real-arithmetic partial specialization of ReadLine
 CTpetra::Details::Impl::ReadLine< SC, GO, true >Complex-arithmetic partial specialization of ReadLine
 CTpetra::Details::RightScaleLocalCrsMatrix< LocalSparseMatrixType, ScalingFactorsViewType, divide >Kokkos::parallel_for functor that right-scales a KokkosSparse::CrsMatrix
 CTpetra::RowInfoAllocation information for a locally owned row in a CrsGraph or CrsMatrix
 CTpetra::RowMatrixTransposer< Scalar, LocalOrdinal, GlobalOrdinal, Node >Construct and (optionally) redistribute the explicitly stored transpose of a CrsMatrix
 CTpetra::Impl::SCAL< ViewType, CoefficientType, IndexType, is_contiguous, rank >Implementation of Tpetra::SCAL function
 CTpetra::Impl::SCAL< ViewType, CoefficientType, IndexType, false, 1 >Implementation of Tpetra::SCAL function, for ViewType rank 1 (i.e., a vector)
 CTpetra::Impl::SCAL< ViewType, CoefficientType, IndexType, false, 2 >Implementation of Tpetra::SCAL function, for ViewType rank 2 (i.e., a matrix)
 CTpetra::Details::ScalarViewTraits< T, D >Traits class for allocating a Kokkos::View<T*, D>
 CTpetra::ScopeGuardScope guard whose destructor automatically calls Tpetra::finalize for you
 CTpetra::SrcDistObjectAbstract base class for objects that can be the source of an Import or Export operation
 CTpetra::Details::TieBreak< LocalOrdinal, GlobalOrdinal >Interface for breaking ties in ownership
 CTpetra::Details::Transfer< LO, GO, NT >Common base class of Import and Export
 CTpetra::Details::Transfer< LocalOrdinal, GlobalOrdinal, Node >
 CTpetra::Details::TieBreak< LocalOrdinal, GlobalOrdinal >::TripletRepresentation of a global index on a process
 CTpetra::Details::TempView::UnifiedContiguousLayout< View1, View2 >Get the contiguous layout that matches as many of the given views as possible. If neither or both arguments are contiguous, favor LayoutLeft
 CTpetra::Details::UnpackAndCombineCrsGraphImpl::UnpackAndCombineFunctor< LocalOrdinal, Packet, RowView, IndicesView, BufferDevice >Unpacks and combines a single row of the CrsGraph
 CTpetra::Details::UnpackAndCombineCrsMatrixImpl::UnpackCrsMatrixAndCombineFunctor< LocalMatrix, LocalMap, BufferDeviceType >Unpacks and combines a single row of the CrsMatrix
 CTpetra::MatrixMarket::Writer< SparseMatrixType >Matrix Market file writer for CrsMatrix and MultiVector