 Belos | |
 DeprecatedAndMayDisappearAtAnyTime | Ifpack2 features that have been DEPRECATED and may DISAPPEAR AT ANY TIME. USE AT YOUR OWN RISK |
 Experimental | Ifpack2 features that are experimental. Use at your own risk |
 Ifpack2 | Preconditioners and smoothers for Tpetra sparse matrices |
  Details | |
   Impl | |
    ChebyshevKernelVectorFunctor | Functor for computing W := alpha * D * (B - A*X) + beta * W and X := X+W |
    InverseDiagonalWithExtraction | Functor for extracting the inverse diagonal of a matrix |
    ScaledDampedResidualVectorFunctor | Functor for computing W := alpha * D * (B - A*X) + beta * W |
   StridedRowView | Structure for read-only views of general matrix rows |
   Amesos2Wrapper | Wrapper class for direct solvers in Amesos2 |
   CanChangeMatrix | Mix-in interface for preconditioners that can change their matrix after construction |
   Chebyshev | Left-scaled Chebyshev iteration |
   ChebyshevKernel | Compute scaled damped residual for Chebyshev |
   DenseSolver | "Preconditioner" that uses LAPACK's dense LU |
   DenseSolver< MatrixType, false > | Partial specialization for stub=false (the default) |
   DenseSolver< MatrixType, true > | Partial specialization for stub=true |
   FastILU_Base | The base class of the Ifpack2 FastILU wrappers (Filu, Fildl and Fic) |
   Fic | The Ifpack2 wrapper to the incomplete Chebyshev preconditioner of ShyLU FastILU |
   Fildl | The Ifpack2 wrapper to the ILDL preconditioner of ShyLU FastILU |
   Filu | The Ifpack2 wrapper to the ILU preconditioner of ShyLU FastILU |
   InverseDiagonalKernel | Compute scaled damped residual for Chebyshev |
   LapackSupportsScalar | Type traits class that says whether Teuchos::LAPACK has a valid implementation for the given ScalarType |
   LinearSolver | Ifpack2's implementation of Trilinos::Details::LinearSolver interface |
   LinearSolverFactory | Interface for a "factory" that creates Ifpack2 solvers |
   MultiVectorLocalGatherScatter | Implementation detail of Ifpack2::Container subclasses |
   NestedPreconditioner | Mix-in interface for nested preconditioners |
   OneLevelFactory | "Factory" for creating single-level preconditioners |
   OverlappingRowGraph | Sparse graph (Tpetra::RowGraph subclass) with ghost rows |
   RowGraph | All Ifpack2 implementations of Tpetra::RowGraph must inherit from this class |
   RowMatrix | All Ifpack2 implementations of Tpetra::RowMatrix must inherit from this class |
   ScaledDampedResidual | Compute scaled damped residual for Chebyshev |
   TriDiSolver | "Preconditioner" that uses LAPACK's tridi LU |
   TriDiSolver< MatrixType, false > | Partial specialization for stub=false (the default) |
   TriDiSolver< MatrixType, true > | Partial specialization for stub=true |
   UserPartitioner | Partition in which the user can define a nonoverlapping partition of the graph in any way they choose |
  BlockHelperDetails | |
   AmD | |
   TpetraLittleBlock | |
   BlockTridiagScalarType | |
   is_cuda | |
   is_hip | |
   is_sycl | |
   ExecutionSpaceFactory | |
   ArrayValueType | |
   SumReducer | |
   ImplType | |
   NormManager | |
  BlockTriDiContainerDetails | |
   ImplNotAvailTag | |
   ImplObject | Forward declaration |
   BlockTridiagScalarType | |
   BlockTridiags | |
   ExtractAndFactorizeTridiagsDefaultModeAndAlgo | |
   MultiVectorConverter | |
   SolveTridiagsDefaultModeAndAlgo< Kokkos::HostSpace > | |
  Experimental | |
   RBILUK | ILU(k) factorization of a given Tpetra::BlockCrsMatrix |
  AdditiveSchwarz | Additive Schwarz domain decomposition for Tpetra sparse matrices |
  BandedContainer | Store and solve a local Banded linear problem |
  BlockRelaxation | Block relaxation preconditioners (or smoothers) for Tpetra::RowMatrix and Tpetra::CrsMatrix sparse matrices |
  BlockTriDiContainer | Store and solve local block tridiagonal linear problems |
  BlockTriDiContainer< MatrixType, BlockTriDiContainerDetails::ImplSimdTag > | |
   ApplyParameters | Input arguments to applyInverseJacobi |
  BlockTriDiContainer< MatrixType, BlockTriDiContainerDetails::ImplNotAvailTag > | |
  BorderedOperator | Ifpack2 bordered operator |
  Chebyshev | Diagonally scaled Chebyshev iteration for Tpetra sparse matrices |
  Container | Interface for creating and solving a set of local linear problems |
  ContainerImpl | The implementation of the numerical features of Container (Jacobi, Gauss-Seidel, SGS). This class allows a custom scalar type (LocalScalarType) to be used for storing blocks and solving the block systems. Hiding this template parameter from the Container interface simplifies the BlockRelaxation and ContainerFactory classes |
  ContainerFactory | A static "factory" that provides a way to register and construct arbitrary Ifpack2::Container subclasses using string keys |
  DatabaseSchwarz | Overlapping Schwarz where redundant patches are not stored explicitly |
  DenseContainer | Store and solve a local dense linear problem |
  Diagonal | Diagonal preconditioner |
  DiagonalFilter | Ifpack2_DiagonalFilter: Filter to modify the diagonal entries of a given Tpetra_RowMatrix |
  DropFilter | Filter based on matrix entries |
  Factory | "Factory" for creating Ifpack2 preconditioners |
  Hiptmair | Wrapper for Hiptmair smoothers |
  IdentitySolver | "Identity" preconditioner |
  IlukGraph | Construct a level filled graph for use in computing an ILU(k) incomplete factorization |
  ILUT | ILUT (incomplete LU factorization with threshold) of a Tpetra sparse matrix |
  LinearPartitioner | A class to define linear partitions |
  LinePartitioner | Ifpack2::LinePartitioner: A class to define partitions into a set of lines |
  LocalFilter | Access only local rows and columns of a sparse matrix |
  LocalSparseTriangularSolver | "Preconditioner" that solves local sparse triangular systems |
  MDF | MDF (incomplete LU factorization with minimum discarded fill reordering) of a Tpetra sparse matrix |
  OverlapGraph | Construct an overlapped graph from a given nonoverlapping graph |
  OverlappingPartitioner | Create overlapping partitions of a local graph |
  OverlappingRowMatrix | Sparse matrix (Tpetra::RowMatrix subclass) with ghost rows |
  Partitioner | Ifpack2::Partitioner: |
  Preconditioner | Interface for all Ifpack2 preconditioners |
  Relaxation | Relaxation preconditioners for Tpetra::RowMatrix and Tpetra::CrsMatrix sparse matrices |
  ReorderFilter | Wraps a Tpetra::RowMatrix in a filter that reorders local rows and columns |
  RILUK | ILU(k) factorization of a given Tpetra::RowMatrix |
  SingletonFilter | Filter based on matrix entries |
  SparseContainer | Store and solve a local sparse linear problem |
  SparsityFilter | Drop entries of a matrix, based on the sparsity pattern |
  TriDiContainer | Store and solve a local TriDi linear problem |
 Teuchos | |
  MatrixMarket | |
  TypeNameTraits< ::Ifpack2::Container< MatrixType > > | Partial specialization of TypeNameTraits for Ifpack2::Container |
 Trilinos | |
  Details | |
 AdditiveSchwarzFilter | Wraps 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) |