Ifpack2 Templated Preconditioning Package
Version 1.0
|
▼NIfpack2 | Preconditioners and smoothers for Tpetra sparse matrices |
▼NBlockTriDiContainerDetails | |
CAmD | |
CArrayValueType | |
CBlockTridiags | |
CBlockTridiagScalarType | |
CExtractAndFactorizeTridiagsDefaultModeAndAlgo | |
CImplNotAvailTag | |
CImplObject | Forward declaration |
CImplType | |
Cis_cuda | |
CMultiVectorConverter | |
CNormManager | |
CSolveTridiagsDefaultModeAndAlgo | |
CSumReducer | |
▼NDetails | |
▼NImpl | |
CChebyshevKernelVectorFunctor | Functor for computing W := alpha * D * (B - A*X) + beta * W and X := X+W |
CScaledDampedResidualVectorFunctor | Functor for computing W := alpha * D * (B - A*X) + beta * W |
CAmesos2Wrapper | Wrapper class for direct solvers in Amesos2 |
CCanChangeMatrix | Mix-in interface for preconditioners that can change their matrix after construction |
CChebyshev | Left-scaled Chebyshev iteration |
CChebyshevKernel | Compute scaled damped residual for Chebyshev |
CDenseSolver | "Preconditioner" that uses LAPACK's dense LU |
CDenseSolver< MatrixType, false > | Partial specialization for stub=false (the default) |
CFastILU_Base | The base class of the Ifpack2 FastILU wrappers (Filu, Fildl and Fic) |
CFic | The Ifpack2 wrapper to the incomplete Chebyshev preconditioner of ShyLU FastILU |
CFildl | The Ifpack2 wrapper to the ILDL preconditioner of ShyLU FastILU |
CFilu | The Ifpack2 wrapper to the ILU preconditioner of ShyLU FastILU |
CLapackSupportsScalar | Type traits class that says whether Teuchos::LAPACK has a valid implementation for the given ScalarType |
CLinearSolver | Ifpack2's implementation of Trilinos::Details::LinearSolver interface |
CLinearSolverFactory | Interface for a "factory" that creates Ifpack2 solvers |
CMultiVectorLocalGatherScatter | Implementation detail of Ifpack2::Container subclasses |
CNestedPreconditioner | Mix-in interface for nested preconditioners |
COneLevelFactory | "Factory" for creating single-level preconditioners |
COverlappingRowGraph | Sparse graph (Tpetra::RowGraph subclass) with ghost rows |
CRowGraph | All Ifpack2 implementations of Tpetra::RowGraph must inherit from this class |
CRowMatrix | All Ifpack2 implementations of Tpetra::RowMatrix must inherit from this class |
CScaledDampedResidual | Compute scaled damped residual for Chebyshev |
CStridedRowView | Structure for read-only views of general matrix rows |
CTriDiSolver | "Preconditioner" that uses LAPACK's tridi LU |
CTriDiSolver< MatrixType, false > | Partial specialization for stub=false (the default) |
CUserPartitioner | Partition in which the user can define a nonoverlapping partition of the graph in any way they choose |
▼NExperimental | |
CRBILUK | ILU(k) factorization of a given Tpetra::BlockCrsMatrix |
CAdditiveSchwarz | Additive Schwarz domain decomposition for Tpetra sparse matrices |
CBandedContainer | Store and solve a local Banded linear problem |
CBlockRelaxation | Block relaxation preconditioners (or smoothers) for Tpetra::RowMatrix and Tpetra::CrsMatrix sparse matrices |
CBlockTriDiContainer | Store and solve local block tridiagonal linear problems |
CBlockTriDiContainer< MatrixType, BlockTriDiContainerDetails::ImplNotAvailTag > | |
▼CBlockTriDiContainer< MatrixType, BlockTriDiContainerDetails::ImplSimdTag > | |
CApplyParameters | Input arguments to applyInverseJacobi |
CBorderedOperator | Ifpack2 bordered operator |
CChebyshev | Diagonally scaled Chebyshev iteration for Tpetra sparse matrices |
CContainer | Interface for creating and solving a set of local linear problems |
CContainerFactory | A static "factory" that provides a way to register and construct arbitrary Ifpack2::Container subclasses using string keys |
CContainerImpl | 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 |
CDenseContainer | Store and solve a local dense linear problem |
CDiagonalFilter | Ifpack2_DiagonalFilter: Filter to modify the diagonal entries of a given Tpetra_RowMatrix |
CDropFilter | Filter based on matrix entries |
CFactory | "Factory" for creating Ifpack2 preconditioners |
CHiptmair | Wrapper for Hiptmair smoothers |
CIdentitySolver | "Identity" preconditioner |
CIlukGraph | Construct a level filled graph for use in computing an ILU(k) incomplete factorization |
CILUT | ILUT (incomplete LU factorization with threshold) of a Tpetra sparse matrix |
CLinearPartitioner | A class to define linear partitions |
CLinePartitioner | Ifpack2::LinePartitioner: A class to define partitions into a set of lines |
CLocalFilter | Access only local rows and columns of a sparse matrix |
CLocalSparseTriangularSolver | "Preconditioner" that solves local sparse triangular systems |
COverlapGraph | Construct an overlapped graph from a given nonoverlapping graph |
COverlappingPartitioner | Create overlapping partitions of a local graph |
COverlappingRowMatrix | Sparse matrix (Tpetra::RowMatrix subclass) with ghost rows |
CPartitioner | Ifpack2::Partitioner: |
CPreconditioner | Interface for all Ifpack2 preconditioners |
CRelaxation | Relaxation preconditioners for Tpetra::RowMatrix and Tpetra::CrsMatrix sparse matrices |
CReorderFilter | Wraps a Tpetra::RowMatrix in a filter that reorders local rows and columns |
CRILUK | ILU(k) factorization of a given Tpetra::RowMatrix |
CSingletonFilter | Filter based on matrix entries |
CSparseContainer | Store and solve a local sparse linear problem |
CSparsityFilter | Drop entries of a matrix, based on the sparsity pattern |
CTriDiContainer | Store and solve a local TriDi linear problem |
▼NTeuchos | |
CTypeNameTraits< ::Ifpack2::Container< MatrixType > > | Partial specialization of TypeNameTraits for Ifpack2::Container |