Ifpack2 Templated Preconditioning Package  Version 1.0
Class List
Here are the classes, structs, unions and interfaces with brief descriptions:
[detail level 1234]
 NIfpack2Preconditioners and smoothers for Tpetra sparse matrices
 NBlockTriDiContainerDetails
 CAmD
 CArrayValueType
 CBlockTridiags
 CBlockTridiagScalarType
 CExecutionSpaceFactory
 CExtractAndFactorizeTridiagsDefaultModeAndAlgo
 CImplNotAvailTag
 CImplObjectForward declaration
 CImplType
 Cis_cuda
 Cis_hip
 CMultiVectorConverter
 CNormManager
 CSolveTridiagsDefaultModeAndAlgo
 CSumReducer
 NDetails
 NImpl
 CChebyshevKernelVectorFunctorFunctor for computing W := alpha * D * (B - A*X) + beta * W and X := X+W
 CInverseDiagonalWithExtractionFunctor for extracting the inverse diagonal of a matrix
 CScaledDampedResidualVectorFunctorFunctor for computing W := alpha * D * (B - A*X) + beta * W
 CAmesos2WrapperWrapper class for direct solvers in Amesos2
 CCanChangeMatrixMix-in interface for preconditioners that can change their matrix after construction
 CChebyshevLeft-scaled Chebyshev iteration
 CChebyshevKernelCompute scaled damped residual for Chebyshev
 CDenseSolver"Preconditioner" that uses LAPACK's dense LU
 CDenseSolver< MatrixType, false >Partial specialization for stub=false (the default)
 CFastILU_BaseThe base class of the Ifpack2 FastILU wrappers (Filu, Fildl and Fic)
 CFicThe Ifpack2 wrapper to the incomplete Chebyshev preconditioner of ShyLU FastILU
 CFildlThe Ifpack2 wrapper to the ILDL preconditioner of ShyLU FastILU
 CFiluThe Ifpack2 wrapper to the ILU preconditioner of ShyLU FastILU
 CInverseDiagonalKernelCompute scaled damped residual for Chebyshev
 CLapackSupportsScalarType traits class that says whether Teuchos::LAPACK has a valid implementation for the given ScalarType
 CLinearSolverIfpack2's implementation of Trilinos::Details::LinearSolver interface
 CLinearSolverFactoryInterface for a "factory" that creates Ifpack2 solvers
 CMultiVectorLocalGatherScatterImplementation detail of Ifpack2::Container subclasses
 CNestedPreconditionerMix-in interface for nested preconditioners
 COneLevelFactory"Factory" for creating single-level preconditioners
 COverlappingRowGraphSparse graph (Tpetra::RowGraph subclass) with ghost rows
 CRowGraphAll Ifpack2 implementations of Tpetra::RowGraph must inherit from this class
 CRowMatrixAll Ifpack2 implementations of Tpetra::RowMatrix must inherit from this class
 CScaledDampedResidualCompute scaled damped residual for Chebyshev
 CStridedRowViewStructure 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)
 CUserPartitionerPartition in which the user can define a nonoverlapping partition of the graph in any way they choose
 NExperimental
 CRBILUKILU(k) factorization of a given Tpetra::BlockCrsMatrix
 CAdditiveSchwarzAdditive Schwarz domain decomposition for Tpetra sparse matrices
 CBandedContainerStore and solve a local Banded linear problem
 CBlockRelaxationBlock relaxation preconditioners (or smoothers) for Tpetra::RowMatrix and Tpetra::CrsMatrix sparse matrices
 CBlockTriDiContainerStore and solve local block tridiagonal linear problems
 CBlockTriDiContainer< MatrixType, BlockTriDiContainerDetails::ImplNotAvailTag >
 CBlockTriDiContainer< MatrixType, BlockTriDiContainerDetails::ImplSimdTag >
 CApplyParametersInput arguments to applyInverseJacobi
 CBorderedOperatorIfpack2 bordered operator
 CChebyshevDiagonally scaled Chebyshev iteration for Tpetra sparse matrices
 CContainerInterface for creating and solving a set of local linear problems
 CContainerFactoryA static "factory" that provides a way to register and construct arbitrary Ifpack2::Container subclasses using string keys
 CContainerImplThe 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
 CDenseContainerStore and solve a local dense linear problem
 CDiagonalFilterIfpack2_DiagonalFilter: Filter to modify the diagonal entries of a given Tpetra_RowMatrix
 CDropFilterFilter based on matrix entries
 CFactory"Factory" for creating Ifpack2 preconditioners
 CHiptmairWrapper for Hiptmair smoothers
 CIdentitySolver"Identity" preconditioner
 CIlukGraphConstruct a level filled graph for use in computing an ILU(k) incomplete factorization
 CILUTILUT (incomplete LU factorization with threshold) of a Tpetra sparse matrix
 CLinearPartitionerA class to define linear partitions
 CLinePartitionerIfpack2::LinePartitioner: A class to define partitions into a set of lines
 CLocalFilterAccess only local rows and columns of a sparse matrix
 CLocalSparseTriangularSolver"Preconditioner" that solves local sparse triangular systems
 COverlapGraphConstruct an overlapped graph from a given nonoverlapping graph
 COverlappingPartitionerCreate overlapping partitions of a local graph
 COverlappingRowMatrixSparse matrix (Tpetra::RowMatrix subclass) with ghost rows
 CPartitionerIfpack2::Partitioner:
 CPreconditionerInterface for all Ifpack2 preconditioners
 CRelaxationRelaxation preconditioners for Tpetra::RowMatrix and Tpetra::CrsMatrix sparse matrices
 CReorderFilterWraps a Tpetra::RowMatrix in a filter that reorders local rows and columns
 CRILUKILU(k) factorization of a given Tpetra::RowMatrix
 CSingletonFilterFilter based on matrix entries
 CSparseContainerStore and solve a local sparse linear problem
 CSparsityFilterDrop entries of a matrix, based on the sparsity pattern
 CTriDiContainerStore and solve a local TriDi linear problem
 NTeuchos
 CTypeNameTraits< ::Ifpack2::Container< MatrixType > >Partial specialization of TypeNameTraits for Ifpack2::Container