Ifpack2 Templated Preconditioning Package  Version 1.0
List of all members
Ifpack2::SparseContainer< MatrixType, InverseType > Class Template Reference

Store and solve a local sparse linear problem. More...

#include <Ifpack2_SparseContainer_decl.hpp>

Inheritance diagram for Ifpack2::SparseContainer< MatrixType, InverseType >:
Inheritance graph
[legend]

Public Types

Public typedefs
typedef MatrixType matrix_type
 The first template parameter of this class. More...
 
typedef InverseType inverse_type
 The second template parameter of this class. More...
 
typedef MatrixType::scalar_type scalar_type
 The type of entries in the input (global) matrix. More...
 
typedef MatrixType::local_ordinal_type local_ordinal_type
 The type of local indices in the input (global) matrix. More...
 
typedef MatrixType::global_ordinal_type global_ordinal_type
 The type of global indices in the input (global) matrix. More...
 
typedef MatrixType::node_type node_type
 The Node type of the input (global) matrix. More...
 
typedef Container< MatrixType >::row_matrix_type row_matrix_type
 The (base class) type of the input matrix. More...
 

Public Member Functions

Constructor and destructor
 SparseContainer (const Teuchos::RCP< const row_matrix_type > &matrix, const Teuchos::ArrayView< const local_ordinal_type > &localRows)
 Constructor. More...
 
virtual ~SparseContainer ()
 Destructor (declared virtual for memory safety of derived classes). More...
 
Get and set methods
virtual size_t getNumRows () const
 The number of rows in the local matrix on the calling process. More...
 
virtual bool isInitialized () const
 Whether the container has been successfully initialized. More...
 
virtual bool isComputed () const
 Whether the container has been successfully computed. More...
 
virtual void setParameters (const Teuchos::ParameterList &List)
 Set all necessary parameters. More...
 
Mathematical functions
virtual void initialize ()
 Do all set-up operations that only require matrix structure. More...
 
virtual void compute ()
 Extract the local diagonal block and prepare the solver. More...
 
virtual void apply (const Tpetra::MultiVector< scalar_type, local_ordinal_type, global_ordinal_type, node_type > &X, Tpetra::MultiVector< scalar_type, local_ordinal_type, global_ordinal_type, node_type > &Y, Teuchos::ETransp mode=Teuchos::NO_TRANS, scalar_type alpha=Teuchos::ScalarTraits< scalar_type >::one(), scalar_type beta=Teuchos::ScalarTraits< scalar_type >::zero()) const
 Compute Y := alpha * M^{-1} X + beta*Y. More...
 
virtual void weightedApply (const Tpetra::MultiVector< scalar_type, local_ordinal_type, global_ordinal_type, node_type > &X, Tpetra::MultiVector< scalar_type, local_ordinal_type, global_ordinal_type, node_type > &Y, const Tpetra::Vector< scalar_type, local_ordinal_type, global_ordinal_type, node_type > &D, Teuchos::ETransp mode=Teuchos::NO_TRANS, scalar_type alpha=Teuchos::ScalarTraits< scalar_type >::one(), scalar_type beta=Teuchos::ScalarTraits< scalar_type >::zero()) const
 Compute Y := alpha * diag(D) * M^{-1} (diag(D) * X) + beta*Y. More...
 
Miscellaneous methods
virtual std::ostream & print (std::ostream &os) const
 Print information about this object to the given output stream. More...
 
Implementation of Teuchos::Describable
virtual std::string description () const
 A one-line description of this object. More...
 
virtual void describe (Teuchos::FancyOStream &out, const Teuchos::EVerbosityLevel verbLevel=Teuchos::Describable::verbLevel_default) const
 Print the object with some verbosity level to the given FancyOStream. More...
 
- Public Member Functions inherited from Ifpack2::Container< MatrixType >
 Container (const Teuchos::RCP< const row_matrix_type > &matrix, const Teuchos::ArrayView< const local_ordinal_type > &localRows)
 Constructor. More...
 
virtual ~Container ()
 Destructor. More...
 
Teuchos::RCP< const row_matrix_type > getMatrix () const
 The input matrix to the constructor. More...
 
Teuchos::ArrayView< const local_ordinal_type > getLocalRows () const
 Local indices of the rows of the input matrix that belong to this block. More...
 

Detailed Description

template<typename MatrixType, typename InverseType>
class Ifpack2::SparseContainer< MatrixType, InverseType >

Store and solve a local sparse linear problem.

Template Parameters
Aspecialization of Tpetra::RowMatrix.

Please refer to the documentation of the Container interface. Currently, Containers are used by BlockRelaxation. Block relaxations need to be able to do two things:

  1. Store the diagonal blocks
  2. Solve linear systems with each diagonal block

These correspond to the two template parameters:

  1. MatrixType, which stores a sparse matrix
  2. InverseType, which solves linear systems with that matrix

This class stores each block as a sparse matrix. Using a sparse matrix for each block is a good idea when the blocks are large and sparse. For small and / or dense blocks, it would probably be better to use an implementation of Container that stores the blocks densely, like DenseContainer. You may also want to consider BandedContainer.

The InverseType template parameter represents the class to use for solving linear systems with a block. In SparseContainer, this template parameter must be a specialization of Preconditioner. Specifically, InverseType must implement the following methods:

We also assume that InverseType has the following typedefs:

MatrixType and InverseType may store values of different types, and may have different template parameters (e.g., local or global ordinal types). You may mix and match so long as implicit conversions are available. The most obvious use case for this are:

SparseContainer currently assumes the following about the column and row Maps of the input matrix:

  1. On all processes, the column and row Maps begin with the same set of on-process entries, in the same order. That is, on-process row and column indices are the same.
  2. On all processes, all off-process indices in the column Map of the input matrix occur after that initial set.

These assumptions may be violated if the input matrix is a Tpetra::CrsMatrix that was constructed with a user-provided column Map. The assumptions are not mathematically necessary and could be relaxed at any time. Implementers who wish to do so will need to modify the extract() method, so that it translates explicitly between local row and column indices, instead of just assuming that they are the same.

Member Typedef Documentation

template<typename MatrixType, typename InverseType>
typedef MatrixType Ifpack2::SparseContainer< MatrixType, InverseType >::matrix_type

The first template parameter of this class.

This must be either a Tpetra::RowMatrix specialization or a Tpetra::CrsMatrix specialization. It may have entirely different template parameters (e.g., scalar_type) than InverseType.

template<typename MatrixType, typename InverseType>
typedef InverseType Ifpack2::SparseContainer< MatrixType, InverseType >::inverse_type

The second template parameter of this class.

This must be a specialization of Ifpack2::Preconditioner or one of its subclasses. It may have entirely different template parameters (e.g., scalar_type) than MatrixType.

template<typename MatrixType, typename InverseType>
typedef MatrixType::scalar_type Ifpack2::SparseContainer< MatrixType, InverseType >::scalar_type

The type of entries in the input (global) matrix.

template<typename MatrixType, typename InverseType>
typedef MatrixType::local_ordinal_type Ifpack2::SparseContainer< MatrixType, InverseType >::local_ordinal_type

The type of local indices in the input (global) matrix.

template<typename MatrixType, typename InverseType>
typedef MatrixType::global_ordinal_type Ifpack2::SparseContainer< MatrixType, InverseType >::global_ordinal_type

The type of global indices in the input (global) matrix.

template<typename MatrixType, typename InverseType>
typedef MatrixType::node_type Ifpack2::SparseContainer< MatrixType, InverseType >::node_type

The Node type of the input (global) matrix.

template<typename MatrixType, typename InverseType>
typedef Container<MatrixType>::row_matrix_type Ifpack2::SparseContainer< MatrixType, InverseType >::row_matrix_type

The (base class) type of the input matrix.

The input matrix to the constructor may be either a Tpetra::RowMatrix specialization or a Tpetra::CrsMatrix specialization. However, we want to make the constructor as general as possible, so we always accept the matrix as a Tpetra::RowMatrix. This typedef is the appropriate specialization of Tpetra::RowMatrix.

Constructor & Destructor Documentation

template<class MatrixType , class InverseType >
Ifpack2::SparseContainer< MatrixType, InverseType >::SparseContainer ( const Teuchos::RCP< const row_matrix_type > &  matrix,
const Teuchos::ArrayView< const local_ordinal_type > &  localRows 
)

Constructor.

matrix [in] The original input matrix. This Container will construct a local diagonal block from the rows given by localRows.

Parameters
localRows[in] The set of (local) rows assigned to this container. localRows[i] == j, where i (from 0 to getNumRows() - 1) indicates the SparseContainer's row, and j indicates the local row in the calling process. localRows.size() gives the number of rows in the local matrix on each process. This may be different on different processes.
template<class MatrixType , class InverseType >
Ifpack2::SparseContainer< MatrixType, InverseType >::~SparseContainer ( )
virtual

Destructor (declared virtual for memory safety of derived classes).

Member Function Documentation

template<class MatrixType , class InverseType >
size_t Ifpack2::SparseContainer< MatrixType, InverseType >::getNumRows ( ) const
virtual

The number of rows in the local matrix on the calling process.

Local matrices must be square. Each process has exactly one matrix. Those matrices may vary in dimensions.

Implements Ifpack2::Container< MatrixType >.

template<class MatrixType , class InverseType >
bool Ifpack2::SparseContainer< MatrixType, InverseType >::isInitialized ( ) const
virtual

Whether the container has been successfully initialized.

Implements Ifpack2::Container< MatrixType >.

template<class MatrixType , class InverseType >
bool Ifpack2::SparseContainer< MatrixType, InverseType >::isComputed ( ) const
virtual

Whether the container has been successfully computed.

Implements Ifpack2::Container< MatrixType >.

template<class MatrixType , class InverseType >
void Ifpack2::SparseContainer< MatrixType, InverseType >::setParameters ( const Teuchos::ParameterList &  List)
virtual

Set all necessary parameters.

Implements Ifpack2::Container< MatrixType >.

template<class MatrixType , class InverseType >
void Ifpack2::SparseContainer< MatrixType, InverseType >::initialize ( )
virtual

Do all set-up operations that only require matrix structure.

Implements Ifpack2::Container< MatrixType >.

template<class MatrixType , class InverseType >
void Ifpack2::SparseContainer< MatrixType, InverseType >::compute ( )
virtual

Extract the local diagonal block and prepare the solver.

Implements Ifpack2::Container< MatrixType >.

template<class MatrixType , class InverseType >
void Ifpack2::SparseContainer< MatrixType, InverseType >::apply ( const Tpetra::MultiVector< scalar_type, local_ordinal_type, global_ordinal_type, node_type > &  X,
Tpetra::MultiVector< scalar_type, local_ordinal_type, global_ordinal_type, node_type > &  Y,
Teuchos::ETransp  mode = Teuchos::NO_TRANS,
scalar_type  alpha = Teuchos::ScalarTraits< scalar_type >::one(),
scalar_type  beta = Teuchos::ScalarTraits< scalar_type >::zero() 
) const
virtual

Compute Y := alpha * M^{-1} X + beta*Y.

Implements Ifpack2::Container< MatrixType >.

template<class MatrixType , class InverseType >
void Ifpack2::SparseContainer< MatrixType, InverseType >::weightedApply ( const Tpetra::MultiVector< scalar_type, local_ordinal_type, global_ordinal_type, node_type > &  X,
Tpetra::MultiVector< scalar_type, local_ordinal_type, global_ordinal_type, node_type > &  Y,
const Tpetra::Vector< scalar_type, local_ordinal_type, global_ordinal_type, node_type > &  D,
Teuchos::ETransp  mode = Teuchos::NO_TRANS,
scalar_type  alpha = Teuchos::ScalarTraits< scalar_type >::one(),
scalar_type  beta = Teuchos::ScalarTraits< scalar_type >::zero() 
) const
virtual

Compute Y := alpha * diag(D) * M^{-1} (diag(D) * X) + beta*Y.

Implements Ifpack2::Container< MatrixType >.

template<class MatrixType , class InverseType >
std::ostream & Ifpack2::SparseContainer< MatrixType, InverseType >::print ( std::ostream &  os) const
virtual

Print information about this object to the given output stream.

operator<< uses this method.

Implements Ifpack2::Container< MatrixType >.

template<class MatrixType , class InverseType >
std::string Ifpack2::SparseContainer< MatrixType, InverseType >::description ( ) const
virtual

A one-line description of this object.

template<class MatrixType , class InverseType >
void Ifpack2::SparseContainer< MatrixType, InverseType >::describe ( Teuchos::FancyOStream &  out,
const Teuchos::EVerbosityLevel  verbLevel = Teuchos::Describable::verbLevel_default 
) const
virtual

Print the object with some verbosity level to the given FancyOStream.


The documentation for this class was generated from the following files: