Ifpack2 Templated Preconditioning Package  Version 1.0
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Groups Pages
Class Hierarchy

Go to the graphical class hierarchy

This inheritance list is sorted roughly, but not completely, alphabetically:
[detail level 12345]
oCAdditiveSchwarzFilterWraps a Tpetra::CrsMatrix or Ifpack2::OverlappingRowMatrix in a filter that removes off-process edges, may reorder rows/columns, and may remove singletons (rows with no connections to other rows)
oCIfpack2::BlockHelperDetails::AmD< MatrixType >
oCIfpack2::BlockTriDiContainer< MatrixType, BlockTriDiContainerDetails::ImplSimdTag >::ApplyParametersInput arguments to applyInverseJacobi
oCIfpack2::BlockHelperDetails::ArrayValueType< T, N >
oCIfpack2::BlockTriDiContainerDetails::BlockTridiags< MatrixType >
oCIfpack2::BlockHelperDetails::BlockTridiagScalarType< T >
oCIfpack2::BlockTriDiContainerDetails::BlockTridiagScalarType< T >
oCIfpack2::BlockTriDiContainer< MatrixType, ImplTagType >Store and solve local block tridiagonal linear problems
oCIfpack2::BorderedOperator< Scalar, LocalOrdinal, GlobalOrdinal, Node >Ifpack2 bordered operator
oCIfpack2::Details::CanChangeMatrix< RowMatrixType >Mix-in interface for preconditioners that can change their matrix after construction
oCIfpack2::Details::CanChangeMatrix< Tpetra::RowMatrix< MatrixType::scalar_type, MatrixType::local_ordinal_type, MatrixType::global_ordinal_type, MatrixType::node_type > >
|oCIfpack2::AdditiveSchwarz< MatrixType, LocalInverseType >Additive Schwarz domain decomposition for Tpetra sparse matrices
|oCIfpack2::BlockRelaxation< MatrixType, ContainerType >Block relaxation preconditioners (or smoothers) for Tpetra::RowMatrix and Tpetra::CrsMatrix sparse matrices
|oCIfpack2::Chebyshev< MatrixType >Diagonally scaled Chebyshev iteration for Tpetra sparse matrices
|oCIfpack2::DatabaseSchwarz< MatrixType >Overlapping Schwarz where redundant patches are not stored explicitly
|oCIfpack2::Details::Amesos2Wrapper< MatrixType >Wrapper class for direct solvers in Amesos2
|oCIfpack2::Details::DenseSolver< MatrixType, stub >"Preconditioner" that uses LAPACK's dense LU
|oCIfpack2::Details::DenseSolver< MatrixType, false >Partial specialization for stub=false (the default)
|oCIfpack2::Details::TriDiSolver< MatrixType, stub >"Preconditioner" that uses LAPACK's tridi LU
|oCIfpack2::Details::TriDiSolver< MatrixType, false >Partial specialization for stub=false (the default)
|oCIfpack2::IdentitySolver< MatrixType >"Identity" preconditioner
|oCIfpack2::ILUT< MatrixType >ILUT (incomplete LU factorization with threshold) of a Tpetra sparse matrix
|oCIfpack2::LocalSparseTriangularSolver< MatrixType >"Preconditioner" that solves local sparse triangular systems
|oCIfpack2::MDF< MatrixType >MDF (incomplete LU factorization with minimum discarded fill reordering) of a Tpetra sparse matrix
|oCIfpack2::Relaxation< MatrixType >Relaxation preconditioners for Tpetra::RowMatrix and Tpetra::CrsMatrix sparse matrices
|\CIfpack2::RILUK< MatrixType >ILU(k) factorization of a given Tpetra::RowMatrix
oCIfpack2::Details::CanChangeMatrix< Tpetra::RowMatrix< Scalar, LocalOrdinal, GlobalOrdinal, Node > >
|\CIfpack2::Details::FastILU_Base< Scalar, LocalOrdinal, GlobalOrdinal, Node >The base class of the Ifpack2 FastILU wrappers (Filu, Fildl and Fic)
oCIfpack2::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 > >
oCIfpack2::Details::ChebyshevKernel< TpetraOperatorType >Compute scaled damped residual for Chebyshev
oCIfpack2::Details::Impl::ChebyshevKernelVectorFunctor< WVector, DVector, BVector, AMatrix, XVector_colMap, XVector_domMap, Scalar, use_beta, do_X_update >Functor for computing W := alpha * D * (B - A*X) + beta * W and X := X+W
oCIfpack2::ContainerFactory< MatrixType >A static "factory" that provides a way to register and construct arbitrary Ifpack2::Container subclasses using string keys
oCIfpack2::BlockHelperDetails::ExecutionSpaceFactory< T >
oCIfpack2::BlockTriDiContainerDetails::ExtractAndFactorizeTridiagsDefaultModeAndAlgo< ArgActiveExecutionMemorySpace >
oCIfpack2::Factory"Factory" for creating Ifpack2 preconditioners
oCIfpack2::BlockTriDiContainerDetails::ImplNotAvailTag
oCIfpack2::BlockTriDiContainerDetails::ImplObject< MatrixType >Forward declaration
oCIfpack2::BlockHelperDetails::ImplType< MatrixType >
oCIfpack2::Details::InverseDiagonalKernel< TpetraOperatorType >Compute scaled damped residual for Chebyshev
oCIfpack2::Details::Impl::InverseDiagonalWithExtraction< DVector, AMatrix, DiagOffsetType, do_L1, fix_tiny >Functor for extracting the inverse diagonal of a matrix
oCIfpack2::BlockHelperDetails::is_cuda< T >
oCIfpack2::BlockHelperDetails::is_hip< T >
oCIfpack2::BlockHelperDetails::is_sycl< T >
oCTeuchos::LabeledObject [external]
|\CTeuchos::Describable [external]
oCIfpack2::Details::LapackSupportsScalar< ScalarType >Type traits class that says whether Teuchos::LAPACK has a valid implementation for the given ScalarType
oCTrilinos::Details::LinearSolver< Tpetra::MultiVector< SC, LO, GO, NT >, Tpetra::Operator< SC, LO, GO, NT >, Tpetra::MultiVector< SC, LO, GO, NT >::mag_type > [external]
|\CIfpack2::Details::LinearSolver< SC, LO, GO, NT >Ifpack2's implementation of Trilinos::Details::LinearSolver interface
oCTrilinos::Details::LinearSolverFactory< Tpetra::MultiVector< SC, LO, GO, NT >, Tpetra::Operator< SC, LO, GO, NT >, Tpetra::MultiVector< SC, LO, GO, NT >::mag_type > [external]
|\CIfpack2::Details::LinearSolverFactory< SC, LO, GO, NT >Interface for a "factory" that creates Ifpack2 solvers
oCIfpack2::BlockTriDiContainerDetails::MultiVectorConverter< MatrixType >
oCIfpack2::Details::MultiVectorLocalGatherScatter< MV_in, MV_out >Implementation detail of Ifpack2::Container subclasses
oCIfpack2::Details::NestedPreconditioner< PrecType >Mix-in interface for nested preconditioners
oCIfpack2::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
oCIfpack2::BlockHelperDetails::NormManager< MatrixType >
oCIfpack2::Details::OneLevelFactory< MatrixType >"Factory" for creating single-level preconditioners
oCIfpack2::Preconditioner< Scalar, LocalOrdinal, GlobalOrdinal, Node >Interface for all Ifpack2 preconditioners
|\CIfpack2::Details::FastILU_Base< Scalar, LocalOrdinal, GlobalOrdinal, Node >The base class of the Ifpack2 FastILU wrappers (Filu, Fildl and Fic)
oCIfpack2::Preconditioner< MatrixType::scalar_type, MatrixType::local_ordinal_type, MatrixType::global_ordinal_type, MatrixType::node_type >
|oCIfpack2::AdditiveSchwarz< MatrixType, LocalInverseType >Additive Schwarz domain decomposition for Tpetra sparse matrices
|oCIfpack2::BlockRelaxation< MatrixType, ContainerType >Block relaxation preconditioners (or smoothers) for Tpetra::RowMatrix and Tpetra::CrsMatrix sparse matrices
|oCIfpack2::Chebyshev< MatrixType >Diagonally scaled Chebyshev iteration for Tpetra sparse matrices
|oCIfpack2::DatabaseSchwarz< MatrixType >Overlapping Schwarz where redundant patches are not stored explicitly
|oCIfpack2::Details::Amesos2Wrapper< MatrixType >Wrapper class for direct solvers in Amesos2
|oCIfpack2::Details::DenseSolver< MatrixType, stub >"Preconditioner" that uses LAPACK's dense LU
|oCIfpack2::Details::DenseSolver< MatrixType, false >Partial specialization for stub=false (the default)
|oCIfpack2::Details::TriDiSolver< MatrixType, stub >"Preconditioner" that uses LAPACK's tridi LU
|oCIfpack2::Details::TriDiSolver< MatrixType, false >Partial specialization for stub=false (the default)
|oCIfpack2::Hiptmair< MatrixType >Wrapper for Hiptmair smoothers
|oCIfpack2::IdentitySolver< MatrixType >"Identity" preconditioner
|oCIfpack2::ILUT< MatrixType >ILUT (incomplete LU factorization with threshold) of a Tpetra sparse matrix
|oCIfpack2::LocalSparseTriangularSolver< MatrixType >"Preconditioner" that solves local sparse triangular systems
|oCIfpack2::MDF< MatrixType >MDF (incomplete LU factorization with minimum discarded fill reordering) of a Tpetra sparse matrix
|oCIfpack2::Relaxation< MatrixType >Relaxation preconditioners for Tpetra::RowMatrix and Tpetra::CrsMatrix sparse matrices
|\CIfpack2::RILUK< MatrixType >ILU(k) factorization of a given Tpetra::RowMatrix
oCIfpack2::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 > >
oCIfpack2::Details::RowGraph< GraphType >All Ifpack2 implementations of Tpetra::RowGraph must inherit from this class
|\CIfpack2::Details::OverlappingRowGraph< GraphType >Sparse graph (Tpetra::RowGraph subclass) with ghost rows
oCIfpack2::Details::RowMatrix< MatrixType >All Ifpack2 implementations of Tpetra::RowMatrix must inherit from this class
|oCIfpack2::DiagonalFilter< MatrixType >Ifpack2_DiagonalFilter: Filter to modify the diagonal entries of a given Tpetra_RowMatrix
|oCIfpack2::DropFilter< MatrixType >Filter based on matrix entries
|oCIfpack2::LocalFilter< MatrixType >Access only local rows and columns of a sparse matrix
|oCIfpack2::OverlappingRowMatrix< MatrixType >Sparse matrix (Tpetra::RowMatrix subclass) with ghost rows
|oCIfpack2::ReorderFilter< MatrixType >Wraps a Tpetra::RowMatrix in a filter that reorders local rows and columns
|oCIfpack2::SingletonFilter< MatrixType >Filter based on matrix entries
|\CIfpack2::SparsityFilter< MatrixType >Drop entries of a matrix, based on the sparsity pattern
oCIfpack2::Details::ScaledDampedResidual< TpetraOperatorType >Compute scaled damped residual for Chebyshev
oCIfpack2::Details::Impl::ScaledDampedResidualVectorFunctor< WVector, DVector, BVector, AMatrix, XVector, Scalar, use_beta >Functor for computing W := alpha * D * (B - A*X) + beta * W
oCIfpack2::BlockTriDiContainerDetails::SolveTridiagsDefaultModeAndAlgo< Kokkos::HostSpace >
oCIfpack2::Details::StridedRowView< Scalar, LocalOrdinal, GlobalOrdinal, Node >Structure for read-only views of general matrix rows
oCIfpack2::BlockHelperDetails::SumReducer< T, N, ExecSpace >
oCIfpack2::BlockHelperDetails::TpetraLittleBlock< LayoutType >
\CTeuchos::TypeNameTraits< ::Ifpack2::Container< MatrixType > >Partial specialization of TypeNameTraits for Ifpack2::Container