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::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::Details::FHT::ComputeRowOffsets< OffsetsViewType, SizeType > | Parallel scan functor for computing "row" offsets |
CTpetra::Experimental::Impl::COPY< ViewType1, ViewType2, LayoutType1, LayoutType2, IndexType, rank > | Implementation of Tpetra::Experimental::COPY function |
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::CrsIJV< Ordinal, Scalar > | Struct representing a sparse matrix entry as an i,j,v triplet |
CTpetra::CrsMatrixStruct< Scalar, LocalOrdinal, GlobalOrdinal, Node > | Struct that holds views of the contents of a CrsMatrix |
CTpetra::DefaultPlatform | Returns 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::Details::ContiguousUniformDirectory< LocalOrdinal, GlobalOrdinal, NodeType > | Implementation of Directory for a contiguous, uniformly distributed Map |
CTpetra::Details::DistributedContiguousDirectory< LocalOrdinal, GlobalOrdinal, NodeType > | Implementation of Directory for a distributed contiguous Map |
CTpetra::Details::DistributedNoncontiguousDirectory< LocalOrdinal, GlobalOrdinal, NodeType > | Implementation of Directory for a distributed noncontiguous Map |
CTpetra::Details::ReplicatedDirectory< LocalOrdinal, GlobalOrdinal, NodeType > | Implementation of Directory for a locally replicated Map |
CTpetra::Distributor | Sets up and executes a communication plan for a Tpetra DistObject |
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::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::InvalidGlobalRowIndex< GlobalOrdinal > | Exception thrown by CrsMatrix on invalid global row index |
CTpetra::Experimental::LittleBlock< Scalar, LO > | Nonowning view of a square dense block in a block matrix |
CTpetra::Experimental::LittleVector< Scalar, LO > | Nonowning view of a set of degrees of freedom corresponding to a mesh point in a block vector or multivector |
CTpetra::Details::LocalMap< LocalOrdinal, GlobalOrdinal, DeviceType > | "Local" part of Map suitable for Kokkos kernels |
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::CrsMatrixMultiplyOp< Scalar, MatScalar, LocalOrdinal, GlobalOrdinal, Node > | A class for wrapping a CrsMatrix multiply in a Operator |
CTpetra::CrsMatrixSolveOp< Scalar, MatScalar, LocalOrdinal, GlobalOrdinal, Node > | Wrap a CrsMatrix instance's triangular solve in an Operator |
►CTpetra::RowMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > | A read-only, row-oriented interface to a sparse matrix |
CTpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node, classic > | Sparse matrix that presents a row-oriented interface that lets users read or modify entries |
►CTpetra::Operator< S, LO, GO, Node > | |
►CTpetra::RTI::KernelOp< S, LO, GO, Node, Tpetra::RTI::detail::BinaryFunctorAdapterWithAlphaBeta< Op, S > > | |
CTpetra::RTI::BinaryOp< S, LO, GO, Node, Op > | Tpetra::Operator wrapping a binary functor using the Tpetra Reduction/Transformation Interface |
CTpetra::RTI::KernelOp< S, LO, GO, Node, Kernel > | Operator wrapping a Kokkos (Classic) kernel using RTI |
►CTpetra::Operator< Scalar, LO, GO, Node > | |
►CTpetra::RowMatrix< Scalar, LO, GO, Node > | |
CTpetra::Experimental::BlockCrsMatrix< Scalar, LO, GO, Node > | Constant block CRS matrix class |
►CTpetra::Operator< Scalar, OperatorType::local_ordinal_type, OperatorType::global_ordinal_type, OperatorType::node_type > | |
CTpetra::details::ApplyOp< Scalar, OperatorType > | A class for wrapping an Operator apply in a Operator |
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::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::RowMatrix< Scalar, LO, GO, Node > | |
►CTpetra::Packable< char, LocalOrdinal > | |
CTpetra::RowMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > | A read-only, row-oriented interface to a sparse matrix |
►CTpetra::Packable< GlobalOrdinal, LocalOrdinal > | |
►CTpetra::RowGraph< LocalOrdinal, GlobalOrdinal, Node > | An abstract interface for graphs accessed by rows |
CTpetra::CrsGraph< LocalOrdinal, GlobalOrdinal, Node, classic > | A distributed graph accessed by rows (adjacency lists) and stored sparsely |
►CTpetra::Packable< GO, LO > | |
►CTpetra::RowGraph< LO, GO, node_type > | |
CTpetra::CrsGraph< LO, GO, node_type > | |
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::RowInfo | Allocation 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::SrcDistObject | Abstract base class for objects that can be the source of an Import or Export operation |
►CTpetra::DistObject< char, LO, GO, Node > | |
CTpetra::Experimental::BlockCrsMatrix< Scalar, LO, GO, Node > | Constant block CRS matrix class |
►CTpetra::DistObject< char, LocalOrdinal, GlobalOrdinal, Node, classic > | |
CTpetra::CrsMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node, classic > | Sparse matrix that presents a row-oriented interface that lets users read or modify entries |
►CTpetra::DistObject< GlobalOrdinal, LocalOrdinal, GlobalOrdinal, Node > | |
CTpetra::CrsGraph< LocalOrdinal, GlobalOrdinal, Node, classic > | A distributed graph accessed by rows (adjacency lists) and stored sparsely |
►CTpetra::DistObject< GO, LO, GO, node_type > | |
CTpetra::CrsGraph< LO, GO, node_type > | |
►CTpetra::DistObject< Scalar, LO, GO, Node > | |
CTpetra::MultiVector< Scalar, LO, GO, Node > | |
►CTpetra::Experimental::BlockMultiVector< Scalar, LO, GO, Node > | MultiVector for multiple degrees of freedom per mesh point |
CTpetra::Experimental::BlockVector< Scalar, LO, GO, Node > | Vector for multiple degrees of freedom per mesh point |
►CTpetra::DistObject< Scalar, LocalOrdinal, GlobalOrdinal, Node > | |
►CTpetra::MultiVector< Scalar, LocalOrdinal, GlobalOrdinal, Node, classic > | One or more distributed dense vectors |
CTpetra::Vector< Scalar, LocalOrdinal, GlobalOrdinal, Node, classic > | A distributed dense vector |
CTpetra::RowMatrix< Scalar, LO, GO, Node > | |
CTpetra::DistObject< Packet, LocalOrdinal, GlobalOrdinal, Node, classic > | Base class for distributed Tpetra objects that support data redistribution |
CTpetra::RowMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > | A read-only, row-oriented interface to a sparse matrix |
►CTpetra::RTI::detail::StdOpKernel< S > | Utility base class for kernels used to define Tpetra::Operator objects |
CTpetra::RTI::detail::BinaryFunctorAdapterWithAlphaBeta< Op, S > | |
CTpetra::RTI::detail::BinaryFunctorAdapterWithAlphaBeta< OP, S > | Adapter class between binary functors and BinaryOp |
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::Export< LocalOrdinal, GlobalOrdinal, Node > | Communication plan for data redistribution from a (possibly) multiply-owned to a uniquely-owned distribution |
CTpetra::Import< LocalOrdinal, GlobalOrdinal, Node > | Communication plan for data redistribution from a uniquely-owned to a (possibly) multiply-owned distribution |
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 >::Triplet | Representation 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 |