|
class | AdditiveSchwarz |
| Additive Schwarz domain decomposition for Tpetra sparse matrices. More...
|
|
class | BandedContainer |
| Store and solve a local Banded linear problem. More...
|
|
class | BandedContainer< MatrixType, LocalScalarType, false > |
| Partial specialization of BandedContainer with the stub implementation, for LocalScalarType types that LAPACK does NOT support. More...
|
|
class | BandedContainer< MatrixType, LocalScalarType, true > |
| Partial specialization with the non-stub implementation, for LocalScalarType types that LAPACK supports. More...
|
|
struct | BelosScalarType |
| Traits class for determining the scalar type to use for Belos. More...
|
|
class | BlockRelaxation |
| Block relaxation preconditioners (or smoothers) for Tpetra::RowMatrix and Tpetra::CrsMatrix sparse matrices. More...
|
|
class | BorderedOperator |
| Ifpack2 bordered operator. More...
|
|
class | Chebyshev |
| Diagonally scaled Chebyshev iteration for Tpetra sparse matrices. More...
|
|
class | Container |
| Interface for creating and solving a local linear problem. More...
|
|
class | DenseContainer |
| Store and solve a local dense linear problem. More...
|
|
class | DenseContainer< MatrixType, LocalScalarType, false > |
| Partial specialization with the stub implementation, for LocalScalarType types that LAPACK does NOT support. More...
|
|
class | DenseContainer< MatrixType, LocalScalarType, true > |
| Partial specialization with the non-stub implementation, for LocalScalarType types that LAPACK supports. More...
|
|
class | DiagonalFilter |
| Ifpack2_DiagonalFilter: Filter to modify the diagonal entries of a given Tpetra_RowMatrix. More...
|
|
class | DropFilter |
| Filter based on matrix entries. More...
|
|
class | Factory |
| "Factory" for creating Ifpack2 preconditioners. More...
|
|
class | Hiptmair |
| Wrapper for Hiptmair smoothers. More...
|
|
class | IdentitySolver |
| "Identity" preconditioner. More...
|
|
class | IlukGraph |
| Construct a level filled graph for use in computing an ILU(k) incomplete factorization. More...
|
|
class | ILUT |
| ILUT (incomplete LU factorization with threshold) of a Tpetra sparse matrix. More...
|
|
class | Krylov |
| Wrapper for iterative linear solvers (e.g., CG or GMRES). More...
|
|
class | LinearPartitioner |
| A class to define linear partitions. More...
|
|
class | LinePartitioner |
|
class | LocalFilter |
| Access only local rows and columns of a sparse matrix. More...
|
|
class | OverlapGraph |
| Construct an overlapped graph from a given nonoverlapping graph. More...
|
|
class | OverlappingPartitioner |
|
class | OverlappingRowMatrix |
| Sparse matrix (Tpetra::RowMatrix subclass) with ghost rows. More...
|
|
class | Partitioner |
| Ifpack2::Partitioner: More...
|
|
class | Preconditioner |
| Interface for all Ifpack2 preconditioners. More...
|
|
class | Relaxation |
| Relaxation preconditioners for Tpetra::RowMatrix and Tpetra::CrsMatrix sparse matrices. More...
|
|
class | ReorderFilter |
| Wraps a Tpetra::RowMatrix in a filter that reorders local rows and columns. More...
|
|
class | RILUK |
| ILU(k) factorization of a given Tpetra::RowMatrix. More...
|
|
class | SingletonFilter |
| Filter based on matrix entries. More...
|
|
class | SparseContainer |
| Store and solve a local sparse linear problem. More...
|
|
class | SparsityFilter |
| Drop entries of a matrix, based on the sparsity pattern. More...
|
|
class | TriDiContainer |
| Store and solve a local TriDi linear problem. More...
|
|
class | TriDiContainer< MatrixType, LocalScalarType, false > |
| Partial specialization of BandedContainer with the stub implementation, for LocalScalarType types that LAPACK does NOT support. More...
|
|
class | TriDiContainer< MatrixType, LocalScalarType, true > |
| Partial specialization with the non-stub implementation, for LocalScalarType types that LAPACK supports. More...
|
|
|
template<class MatrixType > |
std::ostream & | operator<< (std::ostream &os, const Ifpack2::Container< MatrixType > &obj) |
| Print information about the given Container to the output stream os . More...
|
|
template<class GraphType > |
Teuchos::RCP< const GraphType > | createOverlapGraph (const Teuchos::RCP< const GraphType > &inputGraph, const int overlapLevel) |
| Construct an overlapped graph for use with Ifpack2 preconditioners. More...
|
|
template<class MatrixType > |
Teuchos::RCP< const MatrixType > | createOverlapMatrix (const Teuchos::RCP< const MatrixType > &inputMatrix, const int overlapLevel) |
| Construct an overlapped matrix for use with Ifpack2 preconditioners. More...
|
|
bool | supportsUnsymmetric (const std::string &prec_type) |
| true if the specified preconditioner type supports nonsymmetric matrices, else false. More...
|
|
template<typename Ordinal , typename SizeType > |
void | add_to_heap (const Ordinal &idx, Teuchos::Array< Ordinal > &heap, SizeType &heap_len) |
|
template<typename Ordinal , typename SizeType , class Compare > |
void | add_to_heap (const Ordinal &idx, Teuchos::Array< Ordinal > &heap, SizeType &heap_len, Compare comp) |
|
template<typename Ordinal , typename SizeType > |
void | rm_heap_root (Teuchos::Array< Ordinal > &heap, SizeType &heap_len) |
|
template<typename Ordinal , typename SizeType , class Compare > |
void | rm_heap_root (Teuchos::Array< Ordinal > &heap, SizeType &heap_len, Compare comp) |
|
void | getValidParameters (Teuchos::ParameterList ¶ms) |
| Fills a list which contains all the parameters possibly used by Ifpack2. More...
|
|
template<typename T > |
void | getParameter (const Teuchos::ParameterList ¶ms, const std::string &name, T &value) |
| Set a value from a ParameterList if a parameter with the specified name exists. More...
|
|
Preconditioners and smoothers for Tpetra sparse matrices.