Tpetra parallel linear algebra  Version of the Day
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::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
 CTpetra::Experimental::Impl::AbsMax< ViewType1, ViewType2, 1 >Implementation of Tpetra's ABSMAX CombineMode for the small dense vectors in BlockMultiVector and BlockVector
 CTpetra::Experimental::Impl::AbsMax< ViewType1, ViewType2, 2 >Implementation of Tpetra's ABSMAX CombineMode for the small dense blocks in BlockCrsMatrix
 CTpetra::Experimental::Impl::AXPY< CoefficientType, ViewType1, ViewType2, LayoutType1, LayoutType2, IndexType, rank >Implementation of Tpetra::Experimental::AXPY function
 CTpetra::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
 CTpetra::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
 CTpetra::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)
 CTpetra::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)
 CTpetra::RTI::detail::BinaryFunctorAdapter< OP, S1, S2 >Adapter class between kernels for Tpetra::RTI::binary_transform and Tpetra::RTI::detail::binary_transform
 CTpetra::Details::FHT::CheckForDuplicateKeys< OffsetsViewType, PairsViewType, SizeType >Functor for checking whether a FixedHashTable has one or more duplicate entries
 CTpetra::Experimental::Impl::COPY< ViewType1, ViewType2, LayoutType1, LayoutType2, IndexType, rank >Implementation of Tpetra::Experimental::COPY function
 CTpetra::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)
 CTpetra::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)
 CTpetra::Experimental::Impl::COPY< ViewType1, ViewType2, LayoutType1, LayoutType2, IndexType, 1 >Implementation of Tpetra::Experimental::COPY function, for ViewType1 and ViewType2 rank 1 (i.e., vectors)
 CTpetra::Experimental::Impl::COPY< ViewType1, ViewType2, LayoutType1, LayoutType2, IndexType, 2 >Implementation of Tpetra::Experimental::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::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::DefaultPlatformReturns a default platform appropriate for the enviroment
 CKokkos::DeviceGEMM< Scalar, DeviceType >Class that provides GEMM for a particular Kokkos Device
 CTpetra::Directory< LocalOrdinal, GlobalOrdinal, Node >Implement mapping from global ID to process ID and local ID
 CTpetra::Details::Directory< LocalOrdinal, GlobalOrdinal, NodeType >Computes the local ID and process ID corresponding to given global IDs
 CTpetra::DistributorSets up and executes a communication plan for a Tpetra DistObject
 CTpetra::Experimental::Impl::FILL< ViewType, InputType, LayoutType, IndexType, rank >Implementation of Tpetra::Experimental::FILL function
 CTpetra::Experimental::Impl::FILL< ViewType, InputType, LayoutType, IndexType, 1 >Implementation of Tpetra::Experimental::FILL function, for ViewType rank 1 (i.e., a vector)
 CTpetra::Experimental::Impl::FILL< ViewType, InputType, LayoutType, IndexType, 2 >Implementation of Tpetra::Experimental::FILL function, for ViewType rank 2 (i.e., a matrix)
 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< GlobalOrdinal, LocalOrdinal, device_type >
 CTpetra::Details::FixedHashTable< GlobalOrdinal, LocalOrdinal, DeviceType >
 CTpetra::Details::FixedHashTable< GO, LO, device_type >
 CTpetra::Details::FixedHashTable< GO, LO, DT >
 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::Experimental::Impl::GETRS< LittleBlockType, LittleIntVectorType, LittleScalarVectorType, rank >Computes the solution to Ax=b
 CTpetra::Experimental::Impl::GETRS< LittleBlockType, LittleIntVectorType, LittleScalarVectorType, 1 >Special case of GETRS for a single right-hand side
 CTpetra::Experimental::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::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::Map< LocalOrdinal, GlobalOrdinal, Node >Describes a parallel distribution of objects over processes
 CTpetra::Map< LO, GO, Node >
 CTpetra::Map< LO, GO, node_type >
 CTpetra::Details::MapCloner< OutMapType, InMapType >Implementation detail of Map::clone()
 CTpetra::MpiPlatform< Node >Implementation of the Platform concept for MPI-based platforms
 CTpetra::MpiPlatform< ::Tpetra::Details::DefaultTypes::node_type >MpiPlatform specialization for the default Node type
 CTpetra::Details::MultiVectorCloner< DstMultiVectorType, SrcMultiVectorType >Implementation of Tpetra::MultiVector::clone()
 CTpetra::MultiVectorFiller< MV >Adds nonlocal sum-into functionality to Tpetra::MultiVector
 CTpetra::Details::MultiVectorFillerData< MV >Implementation of fill and local assembly for MultiVectorFiller
 CTpetra::Details::MultiVectorFillerData2< MV >Second implementation of fill and local assembly for MultiVectorFiller
 CTpetra::Test::MultiVectorFillerTester< MV >Tests for MultiVectorFiller
 CTpetra::RTI::OneOp< T >A static identity functor, providing a static method identity() that returns one
 CTpetra::Operator< Scalar, LocalOrdinal, GlobalOrdinal, Node >Abstract interface for operators (e.g., matrices and preconditioners)
 CTpetra::Operator< S, LO, GO, Node >
 CTpetra::Operator< Scalar, LO, GO, Node >
 CTpetra::Operator< Scalar, OperatorType::local_ordinal_type, OperatorType::global_ordinal_type, OperatorType::node_type >
 CTpetra::Details::OptColMap< MapType >Implementation detail of makeOptimizedColMap, and makeOptimizedColMapAndImport
 CTpetra::Details::OrdinalTraits< T >Traits class for "invalid" (flag) values of integer types that Tpetra uses as local ordinals or global ordinals
 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, LO >
 CTpetra::Packable< char, LocalOrdinal >
 CTpetra::Packable< GlobalOrdinal, LocalOrdinal >
 CTpetra::Packable< GO, LO >
 CTpetra::Details::PackTraits< T, D >Traits class for packing / unpacking data of type T, using Kokkos data structures that live in the given space D
 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::RTI::ReductionGlob< GOP, ROP, IOP >A type glob containing the types needed for calling Tpetra::RTI::reduce() with individual functors
 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::RTI::detail::RTIPreTransformReductionAdapter< Glob, S1, S2 >Adapter class between kernels for Tpetra::RTI::binary_pre_transform_reduce and Tpetra::RTI::detail::binary_transform
 CTpetra::RTI::detail::RTIPreTransformReductionAdapter3< Glob, S1, S2, S3 >Adapter class between kernels for Tpetra::RTI::binary_pre_transform_reduce and Tpetra::RTI::detail::binary_transform
 CTpetra::RTI::detail::RTIReductionAdapter1< Glob, S >Adapter class between kernels for Tpetra::RTI::binary_transform and Tpetra::RTI::detail::binary_transform
 CTpetra::RTI::detail::RTIReductionAdapter2< Glob, S1, S2 >Adapter class between kernels for Tpetra::RTI::binary_transform and Tpetra::RTI::detail::binary_transform
 CTpetra::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
 CTpetra::Experimental::Impl::SCAL< ViewType, CoefficientType, LayoutType, IndexType, rank >Implementation of Tpetra::Experimental::SCAL function
 CTpetra::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
 CTpetra::Experimental::Impl::SCAL< ViewType, CoefficientType, LayoutType, IndexType, 1 >Implementation of Tpetra::Experimental::SCAL function, for ViewType rank 1 (i.e., a vector)
 CTpetra::Experimental::Impl::SCAL< ViewType, CoefficientType, LayoutType, IndexType, 2 >Implementation of Tpetra::Experimental::SCAL function, for ViewType rank 2 (i.e., a matrix)
 CTpetra::SerialPlatform< Node >Implementation of the Platform concept for non-MPI platforms
 CTpetra::SerialPlatform< Tpetra::Details::DefaultTypes::node_type >SerialPlatform specialization for the default Node type
 CTpetra::SrcDistObjectAbstract base class for objects that can be the source of an Import or Export operation
 CTpetra::RTI::detail::StdOpKernel< S >Utility base class for kernels used to define Tpetra::Operator objects
 CTpetra::RTI::detail::TertiaryFunctorAdapter< OP, S1, S2, S3 >Adapter class between kernels for Tpetra::RTI::tertiary_transform and Tpetra::RTI::detail::tertiary_transform
 CTpetra::RTI::detail::TeuchosValueTypeReductionOpAdapter< OP >Decorator for Kokkos reduction kernels to satisfy requirements for Teuchos::ValueTypeReductionOp
 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::RTI::TransformReductionGlob< TxOP, GOP, ROP, IOP >A type glob containing the types needed for calling Tpetra::RTI::binary_pre_transform_reduce() with individual functors
 CTpetra::Details::TieBreak< LocalOrdinal, GlobalOrdinal >::TripletRepresentation of a global index on a process
 CTpetra::Ext::TypeStack< T, S >Implementation of a Tpetra::Ext::TypeStack, supporting the next to last entry
 CTpetra::Ext::TypeStack< T, TypeStack< S, SS > >Generic implementation of a Tpetra::Ext::TypeStack. This is the model that should be programmed to
 CTpetra::Ext::TypeStackBottom< T >Implementation of a Tpetra::Ext::TypeStack, supporting the last entry
 CTpetra::RTI::detail::UnaryFunctorAdapter< OP, S >Adapter class between kernels for Tpetra::RTI::unary_transform and Tpetra::RTI::detail::unary_transform
 CTpetra::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