CIfpack2::BandedContainer< MatrixType, LocalScalarType, supportsLocalScalarType > | Store and solve a local Banded linear problem |
CIfpack2::BelosScalarType< ScalarType > | Traits class for determining the scalar type to use for Belos |
CIfpack2::BorderedOperator< Scalar, LocalOrdinal, GlobalOrdinal, Node > | Ifpack2 bordered operator |
CIfpack2::Details::CanChangeMatrix< RowMatrixType > | Mix-in interface for preconditioners that can change their matrix after construction |
▼CIfpack2::Details::CanChangeMatrix< Tpetra::RowMatrix< MatrixType::scalar_type, MatrixType::local_ordinal_type, MatrixType::global_ordinal_type, MatrixType::node_type > > | |
CIfpack2::AdditiveSchwarz< MatrixType, LocalInverseType > | Additive Schwarz domain decomposition for Tpetra sparse matrices |
CIfpack2::BlockRelaxation< MatrixType, ContainerType > | Block relaxation preconditioners (or smoothers) for Tpetra::RowMatrix and Tpetra::CrsMatrix sparse matrices |
CIfpack2::Chebyshev< MatrixType > | Diagonally scaled Chebyshev iteration for Tpetra sparse matrices |
CIfpack2::Details::Amesos2Wrapper< MatrixType > | Wrapper class for direct solvers in Amesos2 |
CIfpack2::Details::DenseSolver< MatrixType, stub > | "Preconditioner" that uses LAPACK's dense LU |
CIfpack2::Details::DenseSolver< MatrixType, false > | Partial specialization for stub=false (the default) |
CIfpack2::Details::TriDiSolver< MatrixType, stub > | "Preconditioner" that uses LAPACK's tridi LU |
CIfpack2::Details::TriDiSolver< MatrixType, false > | Partial specialization for stub=false (the default) |
CIfpack2::IdentitySolver< MatrixType > | "Identity" preconditioner |
CIfpack2::ILUT< MatrixType > | ILUT (incomplete LU factorization with threshold) of a Tpetra sparse matrix |
CIfpack2::Krylov< MatrixType > | Wrapper for iterative linear solvers (e.g., CG or GMRES) |
CIfpack2::Relaxation< MatrixType > | Relaxation preconditioners for Tpetra::RowMatrix and Tpetra::CrsMatrix sparse matrices |
CIfpack2::RILUK< MatrixType > | ILU(k) factorization of a given Tpetra::RowMatrix |
▼CIfpack2::Details::CanChangeMatrix< Tpetra::RowMatrix< Tpetra::RowMatrix< MatrixType::scalar_type, MatrixType::local_ordinal_type, MatrixType::global_ordinal_type, MatrixType::node_type >::scalar_type, Tpetra::RowMatrix< MatrixType::scalar_type, MatrixType::local_ordinal_type, MatrixType::global_ordinal_type, MatrixType::node_type >::local_ordinal_type, Tpetra::RowMatrix< MatrixType::scalar_type, MatrixType::local_ordinal_type, MatrixType::global_ordinal_type, MatrixType::node_type >::global_ordinal_type, Tpetra::RowMatrix< MatrixType::scalar_type, MatrixType::local_ordinal_type, MatrixType::global_ordinal_type, MatrixType::node_type >::node_type > > | |
▼CIfpack2::RILUK< Tpetra::RowMatrix< MatrixType::scalar_type, MatrixType::local_ordinal_type, MatrixType::global_ordinal_type, MatrixType::node_type > > | |
CIfpack2::Experimental::RBILUK< MatrixType > | ILU(k) factorization of a given Tpetra::Experimental::BlockCrsMatrix |
CIfpack2::Details::Chebyshev< ScalarType, MV > | Left-scaled Chebyshev iteration |
CIfpack2::Details::Chebyshev< scalar_type, MV > | |
▼CIfpack2::Container< MatrixType > | Interface for creating and solving a local linear problem |
CIfpack2::BandedContainer< MatrixType, LocalScalarType, false > | Partial specialization of BandedContainer with the stub implementation, for LocalScalarType types that LAPACK does NOT support |
CIfpack2::BandedContainer< MatrixType, LocalScalarType, true > | Partial specialization with the non-stub implementation, for LocalScalarType types that LAPACK supports |
CIfpack2::DenseContainer< MatrixType, LocalScalarType, false > | Partial specialization with the stub implementation, for LocalScalarType types that LAPACK does NOT support |
CIfpack2::DenseContainer< MatrixType, LocalScalarType, true > | Partial specialization with the non-stub implementation, for LocalScalarType types that LAPACK supports |
CIfpack2::SparseContainer< MatrixType, InverseType > | Store and solve a local sparse linear problem |
CIfpack2::TriDiContainer< MatrixType, LocalScalarType, false > | Partial specialization of BandedContainer with the stub implementation, for LocalScalarType types that LAPACK does NOT support |
CIfpack2::TriDiContainer< MatrixType, LocalScalarType, true > | Partial specialization with the non-stub implementation, for LocalScalarType types that LAPACK supports |
CIfpack2::DenseContainer< MatrixType, LocalScalarType, supportsLocalScalarType > | Store and solve a local dense linear problem |
CIfpack2::DiagonalFilter< MatrixType > | Ifpack2_DiagonalFilter: Filter to modify the diagonal entries of a given Tpetra_RowMatrix |
CIfpack2::DropFilter< MatrixType > | Filter based on matrix entries |
CIfpack2::Factory | "Factory" for creating Ifpack2 preconditioners |
CIfpack2::IlukGraph< GraphType > | Construct a level filled graph for use in computing an ILU(k) incomplete factorization |
CIfpack2::Details::LapackSupportsScalar< ScalarType > | Type traits class that says whether Teuchos::LAPACK has a valid implementation for the given ScalarType |
CIfpack2::Details::LinearSolver< SC, LO, GO, NT > | Ifpack2's implementation of Trilinos::Details::LinearSolver interface |
CIfpack2::Details::LinearSolverFactory< SC, LO, GO, NT > | Interface for a "factory" that creates Ifpack2 solvers |
CIfpack2::LocalFilter< MatrixType > | Access only local rows and columns of a sparse matrix |
CIfpack2::Details::MultiVectorLocalGatherScatter< MV_in, MV_out > | Implementation detail of Ifpack2::Container subclasses |
CIfpack2::Details::NestedPreconditioner< PrecType > | Mix-in interface for nested preconditioners |
▼CIfpack2::Details::NestedPreconditioner< Preconditioner< MatrixType::scalar_type, MatrixType::local_ordinal_type, MatrixType::global_ordinal_type, MatrixType::node_type > > | |
CIfpack2::AdditiveSchwarz< MatrixType, LocalInverseType > | Additive Schwarz domain decomposition for Tpetra sparse matrices |
CIfpack2::Details::OneLevelFactory< MatrixType > | "Factory" for creating single-level preconditioners |
CIfpack2::OverlapGraph< LocalOrdinal, GlobalOrdinal, Node > | Construct an overlapped graph from a given nonoverlapping graph |
CIfpack2::Details::OverlappingRowGraph< GraphType > | Sparse graph (Tpetra::RowGraph subclass) with ghost rows |
CIfpack2::OverlappingRowMatrix< MatrixType > | Sparse matrix (Tpetra::RowMatrix subclass) with ghost rows |
▼CIfpack2::Partitioner< GraphType > | Ifpack2::Partitioner: |
▼CIfpack2::OverlappingPartitioner< GraphType > | |
CIfpack2::Details::UserPartitioner< GraphType > | Partition in which the user can define a nonoverlapping partition of the graph in any way they choose |
CIfpack2::LinearPartitioner< GraphType > | A class to define linear partitions |
CIfpack2::LinePartitioner< GraphType, Scalar > | |
CIfpack2::Preconditioner< Scalar, LocalOrdinal, GlobalOrdinal, Node > | Interface for all Ifpack2 preconditioners |
▼CIfpack2::Preconditioner< MatrixType::scalar_type, MatrixType::local_ordinal_type, MatrixType::global_ordinal_type, MatrixType::node_type > | |
CIfpack2::AdditiveSchwarz< MatrixType, LocalInverseType > | Additive Schwarz domain decomposition for Tpetra sparse matrices |
CIfpack2::BlockRelaxation< MatrixType, ContainerType > | Block relaxation preconditioners (or smoothers) for Tpetra::RowMatrix and Tpetra::CrsMatrix sparse matrices |
CIfpack2::Chebyshev< MatrixType > | Diagonally scaled Chebyshev iteration for Tpetra sparse matrices |
CIfpack2::Details::Amesos2Wrapper< MatrixType > | Wrapper class for direct solvers in Amesos2 |
CIfpack2::Details::DenseSolver< MatrixType, stub > | "Preconditioner" that uses LAPACK's dense LU |
CIfpack2::Details::DenseSolver< MatrixType, false > | Partial specialization for stub=false (the default) |
CIfpack2::Details::TriDiSolver< MatrixType, stub > | "Preconditioner" that uses LAPACK's tridi LU |
CIfpack2::Details::TriDiSolver< MatrixType, false > | Partial specialization for stub=false (the default) |
CIfpack2::Hiptmair< MatrixType > | Wrapper for Hiptmair smoothers |
CIfpack2::IdentitySolver< MatrixType > | "Identity" preconditioner |
CIfpack2::ILUT< MatrixType > | ILUT (incomplete LU factorization with threshold) of a Tpetra sparse matrix |
CIfpack2::Krylov< MatrixType > | Wrapper for iterative linear solvers (e.g., CG or GMRES) |
CIfpack2::Relaxation< MatrixType > | Relaxation preconditioners for Tpetra::RowMatrix and Tpetra::CrsMatrix sparse matrices |
CIfpack2::RILUK< MatrixType > | ILU(k) factorization of a given Tpetra::RowMatrix |
▼CIfpack2::Preconditioner< Tpetra::RowMatrix< MatrixType::scalar_type, MatrixType::local_ordinal_type, MatrixType::global_ordinal_type, MatrixType::node_type >::scalar_type, Tpetra::RowMatrix< MatrixType::scalar_type, MatrixType::local_ordinal_type, MatrixType::global_ordinal_type, MatrixType::node_type >::local_ordinal_type, Tpetra::RowMatrix< MatrixType::scalar_type, MatrixType::local_ordinal_type, MatrixType::global_ordinal_type, MatrixType::node_type >::global_ordinal_type, Tpetra::RowMatrix< MatrixType::scalar_type, MatrixType::local_ordinal_type, MatrixType::global_ordinal_type, MatrixType::node_type >::node_type > | |
CIfpack2::RILUK< Tpetra::RowMatrix< MatrixType::scalar_type, MatrixType::local_ordinal_type, MatrixType::global_ordinal_type, MatrixType::node_type > > | |
CIfpack2::ReorderFilter< MatrixType > | Wraps a Tpetra::RowMatrix in a filter that reorders local rows and columns |
CIfpack2::SingletonFilter< MatrixType > | Filter based on matrix entries |
CIfpack2::SparsityFilter< MatrixType > | Drop entries of a matrix, based on the sparsity pattern |
CIfpack2::TriDiContainer< MatrixType, LocalScalarType, supportsLocalScalarType > | Store and solve a local TriDi linear problem |