Ifpack2 Templated Preconditioning Package Version 1.0
Loading...
Searching...
No Matches
Namespace List
Here is a list of all documented namespaces with brief descriptions:
[detail level 123]
 NDeprecatedAndMayDisappearAtAnyTimeIfpack2 features that have been DEPRECATED and may DISAPPEAR AT ANY TIME. USE AT YOUR OWN RISK
 NDetailsIfpack2 implementation details
 NExperimentalIfpack2 features that are experimental. Use at your own risk
 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
 CTpetraLittleBlock
 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