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