Tpetra parallel linear algebra  Version of the Day
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Macros Pages
Class Hierarchy

Go to the graphical class hierarchy

This inheritance list is sorted roughly, but not completely, alphabetically:
[detail level 1234]
oCTpetra::Details::AbsMax< Scalar >Functor for the the ABSMAX CombineMode of Import and Export operations
oCTpetra::Experimental::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
oCTpetra::Experimental::Impl::AbsMax< ViewType1, ViewType2, 1 >Implementation of Tpetra's ABSMAX CombineMode for the small dense vectors in BlockMultiVector and BlockVector
oCTpetra::Experimental::Impl::AbsMax< ViewType1, ViewType2, 2 >Implementation of Tpetra's ABSMAX CombineMode for the small dense blocks in BlockCrsMatrix
oCTpetra::Experimental::Impl::AXPY< CoefficientType, ViewType1, ViewType2, LayoutType1, LayoutType2, IndexType, rank >Implementation of Tpetra::Experimental::AXPY function
oCTpetra::Experimental::Impl::AXPY< 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
oCTpetra::Experimental::Impl::AXPY< 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
oCTpetra::Experimental::Impl::AXPY< CoefficientType, ViewType1, ViewType2, LayoutType1, LayoutType2, IndexType, 1 >Implementation of Tpetra::Experimental::AXPY function, for ViewType1 and ViewType2 rank 1 (i.e., vectors)
oCTpetra::Experimental::Impl::AXPY< CoefficientType, ViewType1, ViewType2, LayoutType1, LayoutType2, IndexType, 2 >Implementation of Tpetra::Experimental::AXPY function, for ViewType1 and ViewType2 rank 2 (i.e., matrices)
oCTpetra::Details::BehaviorDescription of Tpetra's behavior
oCTpetra::RTI::detail::BinaryFunctorAdapter< OP, S1, S2 >Adapter class between kernels for Tpetra::RTI::binary_transform and Tpetra::RTI::detail::binary_transform
oCTpetra::Details::Blas::BlasSupportsLayout< LayoutType >Do BLAS libraries (all that are compliant with the BLAS Standard) support the given Kokkos array layout?
oCTpetra::Details::Blas::BlasSupportsScalar< ScalarType >Do BLAS libraries (all that are compliant with the BLAS Standard) support the given "scalar" (matrix entry) type?
oCTpetra::Details::FHT::CheckForDuplicateKeys< OffsetsViewType, PairsViewType, SizeType >Functor for checking whether a FixedHashTable has one or more duplicate entries
oCTpetra::Details::CommRequestBase class for the request (more or less a future) representing a pending nonblocking MPI operation
oCTpetra::Details::Impl::CompareCooGraphEntries< IndexType >Function comparing two CooGraphEntry structs, lexicographically, first by row index, then by column index
oCTpetra::Details::Impl::CooGraphEntry< IndexType >Type of each (row index, column index) pair in the Tpetra::Details::CooMatrix (see below)
oCTpetra::Details::Impl::CooMatrixImpl< SC, GO >Implementation detail of Tpetra::Details::CooMatrix (which see below)
oCTpetra::Experimental::Impl::COPY< ViewType1, ViewType2, LayoutType1, LayoutType2, IndexType, rank >Implementation of Tpetra::Experimental::COPY function
oCTpetra::Experimental::Impl::COPY< 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)
oCTpetra::Experimental::Impl::COPY< 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)
oCTpetra::Experimental::Impl::COPY< ViewType1, ViewType2, LayoutType1, LayoutType2, IndexType, 1 >Implementation of Tpetra::Experimental::COPY function, for ViewType1 and ViewType2 rank 1 (i.e., vectors)
oCTpetra::Experimental::Impl::COPY< ViewType1, ViewType2, LayoutType1, LayoutType2, IndexType, 2 >Implementation of Tpetra::Experimental::COPY function, for ViewType1 and ViewType2 rank 2 (i.e., matrices)
oCTpetra::Details::FHT::CountBuckets< CountsViewType, KeysViewType, SizeType >Parallel for functor for counting "buckets" in the FixedHashTable
oCTpetra::Details::Impl::CountLocalNumDiags< LocalGraphType, LocalMapType >Kokkos::parallel_reduce functor for counting the local number of diagonal entries in a sparse graph
oCTpetra::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
oCTpetra::CrsMatrixStruct< Scalar, LocalOrdinal, GlobalOrdinal, Node >Struct that holds views of the contents of a CrsMatrix
oCTpetra::Details::Impl::DetermineLocalTriangularStructure< LocalGraphType, LocalMapType >Implementation of Tpetra::Details::determineLocalTriangularStructure (which see below)
oCTpetra::Directory< LocalOrdinal, GlobalOrdinal, Node >Implement mapping from global ID to process ID and local ID
oCTpetra::Details::Directory< LocalOrdinal, GlobalOrdinal, NodeType >Computes the local ID and process ID corresponding to given global IDs
oCTpetra::DistributorSets up and executes a communication plan for a Tpetra DistObject
oCTpetra::Details::EquilibrationInfo< ScalarType, DeviceType >Struct storing results of Tpetra::computeRowAndColumnOneNorms
oCTpetra::Details::EquilibrationInfo< val_type, typename NT::device_type >
oCTpetra::Experimental::Impl::FILL< ViewType, InputType, LayoutType, IndexType, rank >Implementation of Tpetra::Experimental::FILL function
oCTpetra::Details::Blas::Impl::Fill< ViewType, ValueType, ExecutionSpace, IndexType, rank >Implementation of ::Tpetra::Details::Blas::fill
oCTpetra::Experimental::Impl::FILL< ViewType, InputType, LayoutType, IndexType, 1 >Implementation of Tpetra::Experimental::FILL function, for ViewType rank 1 (i.e., a vector)
oCTpetra::Experimental::Impl::FILL< ViewType, InputType, LayoutType, IndexType, 2 >Implementation of Tpetra::Experimental::FILL function, for ViewType rank 2 (i.e., a matrix)
oCTpetra::Details::Blas::Impl::Fill< ViewType, ValueType, ExecutionSpace, IndexType, 1 >Specialization for rank-1 Views
oCTpetra::Details::Blas::Impl::Fill< ViewType, ValueType, ExecutionSpace, IndexType, 2 >Specialization for rank-2 Views
oCTpetra::Details::FHT::FillPairs< PairsViewType, KeysViewType, CountsViewType, SizeType >Parallel reduce functor for filling the FixedHashTable, and computing the min and max keys
oCTpetra::Details::FHT::FillPairsResult< KeyType >Reduction result for FillPairs functor below
oCTpetra::Details::FixedHashTable< KeyType, ValueType, DeviceType >
oCTpetra::Details::FixedHashTable< GlobalOrdinal, LocalOrdinal, device_type >
oCTpetra::Details::FixedHashTable< GlobalOrdinal, LocalOrdinal, DeviceType >
oCTpetra::Details::FixedHashTable< GO, LO, device_type >
oCTpetra::Details::FixedHashTable< GO, LO, DT >
oCTpetra::Details::Impl::GetGraphDiagOffsets< LO, GO, DeviceType, DiagOffsetType >Implementation detail of Tpetra::Details::getGraphDiagOffsets, which in turn is an implementation detail of Tpetra::CrsGraph
oCTpetra::Details::Impl::GetLocalNumDiags< MatrixType >Implementation of Tpetra::Details::getLocalNumDiags (see below)
oCTpetra::Details::Impl::GetLocalNumDiags< ::Tpetra::CrsGraph< LO, GO, NT > >Specialization of GetLocalNumDiags for CrsGraph
oCTpetra::Details::Impl::GetLocalNumDiags< ::Tpetra::RowGraph< LO, GO, NT > >Specialization of GetLocalNumDiags for RowGraph
oCTpetra::Experimental::Impl::GETRS< LittleBlockType, LittleIntVectorType, LittleScalarVectorType, rank >Computes the solution to Ax=b
oCTpetra::Experimental::Impl::GETRS< LittleBlockType, LittleIntVectorType, LittleScalarVectorType, 1 >Special case of GETRS for a single right-hand side
oCTpetra::Experimental::Impl::GETRS< LittleBlockType, LittleIntVectorType, LittleScalarVectorType, 2 >Special case of GETRS for multiple right-hand sides
oCTpetra::Details::Hash< KeyType, DeviceType, OffsetType, ResultType >The hash function for FixedHashTable
oCTpetra::Details::Hash< KeyType, DeviceType, OffsetType, int >Specialization for ResultType = int
oCTpetra::Details::HashTable< KeyType, ValueType >
oCTpetra::Details::Impl::Iallreduce< PacketType, SendLayoutType, SendDeviceType, RecvLayoutType, RecvDeviceType, rank >Implementation of ::Tpetra::Details::iallreduce
oCTpetra::Details::Impl::Iallreduce< PacketType, SendLayoutType, SendDeviceType, RecvLayoutType, RecvDeviceType, 0 >Partial specialization of Iallreduce for rank-0 send and receive buffers
oCTpetra::Details::Impl::Iallreduce< PacketType, SendLayoutType, SendDeviceType, RecvLayoutType, RecvDeviceType, 1 >Partial specialization of Iallreduce for rank-1 send and receive buffers
oCTpetra::Details::Impl::IallreduceCommRequest< PacketType, SendLayoutType, SendDeviceType, RecvLayoutType, RecvDeviceType, rank >Object representing a pending ::Tpetra::Details::iallreduce operation
oCTpetra::ImportExportData< LocalOrdinal, GlobalOrdinal, Node >Implementation detail of Import and Export
oCTpetra::Details::InvalidGlobalIndex< GlobalOrdinal >Exception thrown by CrsMatrix on invalid global index
oCTpetra::Details::LeftScaleLocalCrsMatrix< LocalSparseMatrixType, ScalingFactorsViewType, divide >Kokkos::parallel_for functor that left-scales a KokkosSparse::CrsMatrix
oCTpetra::Details::LocalMap< LocalOrdinal, GlobalOrdinal, DeviceType >"Local" part of Map suitable for Kokkos kernels
oCTpetra::Details::LocalMap< LO, GO, device_type >
oCTpetra::Details::LocalMap< LO, GO, DT >
oCTpetra::Details::LocalTriangularStructureResult< LO >Return value of determineLocalTriangularStructure
oCTpetra::Map< LocalOrdinal, GlobalOrdinal, Node >A parallel distribution of indices over processes
oCTpetra::Map< LO, GO, Node >
oCTpetra::Map< LO, GO, node_type >
oCTpetra::Details::MapCloner< OutMapType, InMapType >Implementation detail of Map::clone()
oCTpetra::Details::UnpackAndCombineCrsMatrixImpl::NumEntriesFunctor< LO, DT, BDT >Kokkos::parallel_reduce functor to determine the number of entries (to unpack) in a KokkosSparse::CrsMatrix to pack
oCTpetra::Details::PackCrsMatrixImpl::NumPacketsAndOffsetsFunctor< OutputOffsetsViewType, CountsViewType, InputOffsetsViewType, InputLocalRowIndicesViewType, InputLocalRowPidsViewType, debug >Compute the number of packets and offsets for the pack procedure
oCTpetra::Details::PackCrsGraphImpl::NumPacketsAndOffsetsFunctor< OutputOffsetsViewType, CountsViewType, InputOffsetsViewType, InputLocalRowIndicesViewType, InputLocalRowPidsViewType, debug >Compute the number of packets and offsets for the pack procedure
oCTpetra::RTI::OneOp< T >A static identity functor, providing a static method identity() that returns one
oCTpetra::Operator< Scalar, LocalOrdinal, GlobalOrdinal, Node >Abstract interface for operators (e.g., matrices and preconditioners)
oCTpetra::Operator< S, LO, GO, Node >
oCTpetra::Operator< Scalar, LO, GO, Node >
oCTpetra::Operator< Scalar, OperatorType::local_ordinal_type, OperatorType::global_ordinal_type, OperatorType::node_type >
oCTpetra::Details::OptColMap< MapType >Implementation detail of makeOptimizedColMap, and makeOptimizedColMapAndImport
oCTpetra::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?
oCTpetra::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
oCTpetra::Packable< char, LO >
oCTpetra::Packable< char, LocalOrdinal >
oCTpetra::Packable< GlobalOrdinal, LocalOrdinal >
oCTpetra::Packable< GO, LO >
oCTpetra::Details::PackTraits< T, D >Traits class for packing / unpacking data of type T, using Kokkos data structures that live in the given space D
oCTpetra::Details::PackTraits< int, DT >
oCTpetra::Details::PackTraits< int, OtherDeviceType >
oCTpetra::Details::PackTraits< LO, BufferDeviceType >
oCTpetra::Details::PackTraits< LO, OtherDeviceType >
oCTpetra::Details::ProfilingRegionProfile the given scope
oCTpetra::project1st< Arg1, Arg2 >Binary function that returns its first argument
oCTpetra::project2nd< Arg1, Arg2 >Binary function that returns its second argument
oCTpetra::MatrixMarket::Reader< SparseMatrixType >Matrix Market file reader for CrsMatrix and MultiVector
oCTpetra::Details::Impl::ReadLine< SC, GO, isComplex >Implementation of the readLine stand-alone function in this namespace (see below)
oCTpetra::Details::Impl::ReadLine< SC, GO, false >Real-arithmetic partial specialization of ReadLine
oCTpetra::Details::Impl::ReadLine< SC, GO, true >Complex-arithmetic partial specialization of ReadLine
oCTpetra::RTI::ReductionGlob< GOP, ROP, IOP >A type glob containing the types needed for calling Tpetra::RTI::reduce() with individual functors
oCTpetra::Details::RightScaleLocalCrsMatrix< LocalSparseMatrixType, ScalingFactorsViewType, divide >Kokkos::parallel_for functor that right-scales a KokkosSparse::CrsMatrix
oCTpetra::RowInfoAllocation information for a locally owned row in a CrsGraph or CrsMatrix
oCTpetra::RowMatrixTransposer< Scalar, LocalOrdinal, GlobalOrdinal, Node >Construct and (optionally) redistribute the explicitly stored transpose of a CrsMatrix
oCTpetra::RTI::detail::RTIPreTransformReductionAdapter< Glob, S1, S2 >Adapter class between kernels for Tpetra::RTI::binary_pre_transform_reduce and Tpetra::RTI::detail::binary_transform
oCTpetra::RTI::detail::RTIPreTransformReductionAdapter3< Glob, S1, S2, S3 >Adapter class between kernels for Tpetra::RTI::binary_pre_transform_reduce and Tpetra::RTI::detail::binary_transform
oCTpetra::RTI::detail::RTIReductionAdapter1< Glob, S >Adapter class between kernels for Tpetra::RTI::binary_transform and Tpetra::RTI::detail::binary_transform
oCTpetra::RTI::detail::RTIReductionAdapter2< Glob, S1, S2 >Adapter class between kernels for Tpetra::RTI::binary_transform and Tpetra::RTI::detail::binary_transform
oCTpetra::RTI::detail::RTIReductionAdapter3< Glob, S1, S2, S3 >Adapter class between kernels for Tpetra::RTI::binary_transform and Tpetra::RTI::detail::binary_transform for three vectors
oCTpetra::Experimental::Impl::SCAL< ViewType, CoefficientType, LayoutType, IndexType, rank >Implementation of Tpetra::Experimental::SCAL function
oCTpetra::Experimental::Impl::SCAL< ViewType, CoefficientType, Kokkos::LayoutRight, IndexType, 2 >Implementation of Tpetra::Experimental::SCAL function, for ViewType rank 2 (i.e., a matrix), and LayoutType = LayoutRight
oCTpetra::Experimental::Impl::SCAL< ViewType, CoefficientType, LayoutType, IndexType, 1 >Implementation of Tpetra::Experimental::SCAL function, for ViewType rank 1 (i.e., a vector)
oCTpetra::Experimental::Impl::SCAL< ViewType, CoefficientType, LayoutType, IndexType, 2 >Implementation of Tpetra::Experimental::SCAL function, for ViewType rank 2 (i.e., a matrix)
oCTpetra::ScopeGuardScope guard whose destructor automatically calls Tpetra::finalize for you
oCTpetra::SrcDistObjectAbstract base class for objects that can be the source of an Import or Export operation
oCTpetra::RTI::detail::StdOpKernel< S >Utility base class for kernels used to define Tpetra::Operator objects
oCTpetra::RTI::detail::TertiaryFunctorAdapter< OP, S1, S2, S3 >Adapter class between kernels for Tpetra::RTI::tertiary_transform and Tpetra::RTI::detail::tertiary_transform
oCTpetra::RTI::detail::TeuchosValueTypeReductionOpAdapter< OP >Decorator for Kokkos reduction kernels to satisfy requirements for Teuchos::ValueTypeReductionOp
oCTpetra::Details::TieBreak< LocalOrdinal, GlobalOrdinal >Interface for breaking ties in ownership
oCTpetra::Details::Transfer< LO, GO, NT >Common base class of Import and Export
oCTpetra::Details::Transfer< LocalOrdinal, GlobalOrdinal, Node >
oCTpetra::RTI::TransformReductionGlob< TxOP, GOP, ROP, IOP >A type glob containing the types needed for calling Tpetra::RTI::binary_pre_transform_reduce() with individual functors
oCTpetra::Details::TieBreak< LocalOrdinal, GlobalOrdinal >::TripletRepresentation of a global index on a process
oCTpetra::Ext::TypeStack< T, S >Implementation of a Tpetra::Ext::TypeStack, supporting the next to last entry
oCTpetra::Ext::TypeStack< T, TypeStack< S, SS > >Generic implementation of a Tpetra::Ext::TypeStack. This is the model that should be programmed to
oCTpetra::Ext::TypeStackBottom< T >Implementation of a Tpetra::Ext::TypeStack, supporting the last entry
oCTpetra::RTI::detail::UnaryFunctorAdapter< OP, S >Adapter class between kernels for Tpetra::RTI::unary_transform and Tpetra::RTI::detail::unary_transform
oCTpetra::Details::UnpackAndCombineCrsGraphImpl::UnpackAndCombineFunctor< LocalOrdinal, Packet, RowView, IndicesView, Device, BufferDevice >Unpacks and combines a single row of the CrsGraph
oCTpetra::Details::UnpackAndCombineCrsMatrixImpl::UnpackCrsMatrixAndCombineFunctor< LocalMatrix, LocalMap, BufferDeviceType >Unpacks and combines a single row of the CrsMatrix
oCTpetra::MatrixMarket::Writer< SparseMatrixType >Matrix Market file writer for CrsMatrix and MultiVector
\CTpetra::RTI::ZeroOp< T >A static identity functor, providing a static method identity() that returns zero