Ifpack2 Templated Preconditioning Package  Version 1.0
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Groups Pages
List of all members
Ifpack2::Details::Amesos2Wrapper< MatrixType > Class Template Reference

Wrapper class for direct solvers in Amesos2. More...

#include <Ifpack2_Details_Amesos2Wrapper_decl.hpp>

Inheritance diagram for Ifpack2::Details::Amesos2Wrapper< MatrixType >:
Inheritance graph
[legend]

Public Types

Typedefs
typedef MatrixType::scalar_type scalar_type
 The type of the entries of the input MatrixType. More...
 
typedef
MatrixType::local_ordinal_type 
local_ordinal_type
 The type of local indices in the input MatrixType. More...
 
typedef
MatrixType::global_ordinal_type 
global_ordinal_type
 The type of global indices in the input MatrixType. More...
 
typedef MatrixType::node_type node_type
 The Node type used by the input MatrixType. More...
 
typedef Teuchos::ScalarTraits
< scalar_type >::magnitudeType 
magnitude_type
 The type of the magnitude (absolute value) of a matrix entry. More...
 
typedef Tpetra::RowMatrix
< scalar_type,
local_ordinal_type,
global_ordinal_type, node_type
row_matrix_type
 Type of the Tpetra::RowMatrix specialization that this class uses. More...
 
typedef Tpetra::Map
< local_ordinal_type,
global_ordinal_type, node_type
map_type
 Type of the Tpetra::Map specialization that this class uses. More...
 
typedef Tpetra::CrsMatrix
< scalar_type,
local_ordinal_type,
global_ordinal_type, node_type
crs_matrix_type
 Type of the Tpetra::CrsMatrix specialization that this class uses. More...
 
- Public Types inherited from Ifpack2::Preconditioner< MatrixType::scalar_type, MatrixType::local_ordinal_type, MatrixType::global_ordinal_type, MatrixType::node_type >
typedef Teuchos::ScalarTraits
< MatrixType::scalar_type >
::magnitudeType 
magnitude_type
 The type of the magnitude (absolute value) of a matrix entry. More...
 

Public Member Functions

Constructors and destructor
 Amesos2Wrapper (const Teuchos::RCP< const row_matrix_type > &A)
 Constructor. More...
 
virtual ~Amesos2Wrapper ()
 Destructor. More...
 
Methods for setting up and computing the factorization
void setParameters (const Teuchos::ParameterList &params)
 Set parameters. More...
 
void initialize ()
 Compute the preordering and symbolic factorization of the matrix. More...
 
bool isInitialized () const
 Returns true if the preconditioner has been successfully initialized. More...
 
void compute ()
 Compute the numeric factorization of the matrix. More...
 
bool isComputed () const
 True if compute() completed successfully, else false. More...
 
Implementation of Ifpack2::Details::CanChangeMatrix
virtual void setMatrix (const Teuchos::RCP< const row_matrix_type > &A)
 Change the matrix to be preconditioned. More...
 
Implementation of Tpetra::Operator
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
 Apply the preconditioner to X, resulting in Y. More...
 
Teuchos::RCP< const map_typegetDomainMap () const
 Tpetra::Map representing the domain of this operator. More...
 
Teuchos::RCP< const map_typegetRangeMap () const
 Tpetra::Map representing the range of this operator. More...
 
bool hasTransposeApply () const
 Whether this object's apply() method can apply the transpose (or conjugate transpose, if applicable). More...
 
Mathematical functions
Teuchos::RCP< const
Teuchos::Comm< int > > 
getComm () const
 The input matrix's communicator. More...
 
Teuchos::RCP< const
row_matrix_type
getMatrix () const
 The input matrix; the matrix to be preconditioned. More...
 
int getNumInitialize () const
 The total number of successful calls to initialize(). More...
 
int getNumCompute () const
 The total number of successful calls to compute(). More...
 
int getNumApply () const
 The total number of successful calls to apply(). More...
 
double getInitializeTime () const
 The total time in seconds spent in successful calls to initialize(). More...
 
double getComputeTime () const
 The total time in seconds spent in successful calls to compute(). More...
 
double getApplyTime () const
 The total time in seconds spent in successful calls to apply(). More...
 
Implementation of Teuchos::Describable
std::string description () const
 A one-line description of this object. More...
 
void describe (Teuchos::FancyOStream &out, const Teuchos::EVerbosityLevel verbLevel=Teuchos::Describable::verbLevel_default) const
 Print the object with some verbosity level to the given output stream. More...
 
- Public Member Functions inherited from Ifpack2::Preconditioner< MatrixType::scalar_type, MatrixType::local_ordinal_type, MatrixType::global_ordinal_type, MatrixType::node_type >
virtual ~Preconditioner ()
 Destructor. More...
 
- Public Member Functions inherited from Ifpack2::Details::CanChangeMatrix< Tpetra::RowMatrix< MatrixType::scalar_type, MatrixType::local_ordinal_type, MatrixType::global_ordinal_type, MatrixType::node_type > >
virtual void setMatrix (const Teuchos::RCP< const Tpetra::RowMatrix< MatrixType::scalar_type, MatrixType::local_ordinal_type, MatrixType::global_ordinal_type, MatrixType::node_type > > &A)=0
 Set the new matrix. More...
 
virtual ~CanChangeMatrix ()
 Destructor. More...
 

Detailed Description

template<class MatrixType>
class Ifpack2::Details::Amesos2Wrapper< MatrixType >

Wrapper class for direct solvers in Amesos2.

Template Parameters
MatrixTypeA specialization of Tpetra::RowMatrix.

This class computes a sparse factorization of the input matrix A using Amesos2. The apply() method solves linear system(s) using that factorization. As with all Ifpack2 preconditioners, initialize() computes the symbolic factorization, and compute() computes the numeric factorization.

Warning
This class is an implementation detail of Ifpack2. Users must not rely on this class. It may go away or its interface may change at any time.
This class creates a local filter. In particular, if the matrix is not a Tpetra::CrsMatrix instance (this class will check this at run time using a dynamic cast), then this class will perform a deep copy to produce a CrsMatrix. This will happen, for example, if you are doing additive Schwarz with nonzero overlap, and apply Amesos2 as the subdomain solve. This deep copy is required by Amesos2, and is in addition to any data copying that Amesos2 may do internally to satisfy TPL storage formats.

Member Typedef Documentation

template<class MatrixType>
typedef MatrixType::scalar_type Ifpack2::Details::Amesos2Wrapper< MatrixType >::scalar_type

The type of the entries of the input MatrixType.

template<class MatrixType>
typedef MatrixType::local_ordinal_type Ifpack2::Details::Amesos2Wrapper< MatrixType >::local_ordinal_type

The type of local indices in the input MatrixType.

template<class MatrixType>
typedef MatrixType::global_ordinal_type Ifpack2::Details::Amesos2Wrapper< MatrixType >::global_ordinal_type

The type of global indices in the input MatrixType.

template<class MatrixType>
typedef MatrixType::node_type Ifpack2::Details::Amesos2Wrapper< MatrixType >::node_type

The Node type used by the input MatrixType.

template<class MatrixType>
typedef Teuchos::ScalarTraits<scalar_type>::magnitudeType Ifpack2::Details::Amesos2Wrapper< MatrixType >::magnitude_type

The type of the magnitude (absolute value) of a matrix entry.

template<class MatrixType>
typedef Tpetra::RowMatrix<scalar_type, local_ordinal_type, global_ordinal_type, node_type> Ifpack2::Details::Amesos2Wrapper< MatrixType >::row_matrix_type

Type of the Tpetra::RowMatrix specialization that this class uses.

template<class MatrixType>
typedef Tpetra::Map<local_ordinal_type, global_ordinal_type, node_type> Ifpack2::Details::Amesos2Wrapper< MatrixType >::map_type

Type of the Tpetra::Map specialization that this class uses.

template<class MatrixType>
typedef Tpetra::CrsMatrix<scalar_type, local_ordinal_type, global_ordinal_type, node_type> Ifpack2::Details::Amesos2Wrapper< MatrixType >::crs_matrix_type

Type of the Tpetra::CrsMatrix specialization that this class uses.

Constructor & Destructor Documentation

template<class MatrixType >
Ifpack2::Details::Amesos2Wrapper< MatrixType >::Amesos2Wrapper ( const Teuchos::RCP< const row_matrix_type > &  A)
explicit

Constructor.

Parameters
A[in] The sparse matrix to factor, as a Tpetra::RowMatrix. (Tpetra::CrsMatrix inherits from this, so you may use a Tpetra::CrsMatrix here instead.)
template<class MatrixType >
Ifpack2::Details::Amesos2Wrapper< MatrixType >::~Amesos2Wrapper ( )
virtual

Destructor.

Member Function Documentation

template<class MatrixType >
void Ifpack2::Details::Amesos2Wrapper< MatrixType >::setParameters ( const Teuchos::ParameterList params)
virtual
template<class MatrixType >
void Ifpack2::Details::Amesos2Wrapper< MatrixType >::initialize ( )
virtual

Compute the preordering and symbolic factorization of the matrix.

You must call this method before you may call compute() or apply(), under the following conditions:

  1. If you have not yet called initialize() before on this instance
  2. If you have just called setMatrix() with a nonnull matrix
  3. If the structure of the sparse matrix has changed

Please also see the documentation of compute() for the conditions under which you must call compute() before calling apply().

Implements Ifpack2::Preconditioner< MatrixType::scalar_type, MatrixType::local_ordinal_type, MatrixType::global_ordinal_type, MatrixType::node_type >.

template<class MatrixType>
bool Ifpack2::Details::Amesos2Wrapper< MatrixType >::isInitialized ( ) const
inlinevirtual
template<class MatrixType >
void Ifpack2::Details::Amesos2Wrapper< MatrixType >::compute ( )
virtual

Compute the numeric factorization of the matrix.

You must call this method before you may call apply(), under the following conditions:

  1. If you have not yet called compute() before on this instance
  2. If the values in the sparse matrix has changed

Please also see the documentation of initialize() for the conditions under which you must call initialize() before calling compute() or apply().

Implements Ifpack2::Preconditioner< MatrixType::scalar_type, MatrixType::local_ordinal_type, MatrixType::global_ordinal_type, MatrixType::node_type >.

template<class MatrixType>
bool Ifpack2::Details::Amesos2Wrapper< MatrixType >::isComputed ( ) const
inlinevirtual
template<class MatrixType >
void Ifpack2::Details::Amesos2Wrapper< MatrixType >::setMatrix ( const Teuchos::RCP< const row_matrix_type > &  A)
virtual

Change the matrix to be preconditioned.

Parameters
A[in] The new matrix.
Postcondition
! isInitialized ()
! isComputed ()

Calling this method resets the preconditioner's state. After calling this method with a nonnull input, you must first call initialize() and compute() (in that order) before you may call apply().

You may call this method with a null input. If A is null, then you may not call initialize() or compute() until you first call this method again with a nonnull input. This method invalidates any previous factorization whether or not A is null, so calling setMatrix() with a null input is one way to clear the preconditioner's state (and free any memory that it may be using).

The new matrix A need not necessarily have the same Maps or even the same communicator as the original matrix.

template<class MatrixType >
void Ifpack2::Details::Amesos2Wrapper< MatrixType >::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

Apply the preconditioner to X, resulting in Y.

If \(M^{-1}\) represents the action of the preconditioner, then this routine computes \(Y := beta \cdot Y + alpha \cdot Op(M^{-1}) X\), where \(Op(M^{-1})\) can be either \(M^{-1}\), \(M^{-T}\), or \(M^{-H}\), depending on mode.

Parameters
X[in] Input multivector; "right-hand side" of the solve.
Y[out] Output multivector; result of the solve.
mode[in] Whether to solve with the original matrix, its transpose, or its conjugate transpose.
alpha[in] Scaling factor for the result of applying the preconditioner.
alpha[in] Scaling factor for Y.

Implements Ifpack2::Preconditioner< MatrixType::scalar_type, MatrixType::local_ordinal_type, MatrixType::global_ordinal_type, MatrixType::node_type >.

template<class MatrixType >
Teuchos::RCP< const typename Amesos2Wrapper< MatrixType >::map_type > Ifpack2::Details::Amesos2Wrapper< MatrixType >::getDomainMap ( ) const
virtual
template<class MatrixType >
Teuchos::RCP< const typename Amesos2Wrapper< MatrixType >::map_type > Ifpack2::Details::Amesos2Wrapper< MatrixType >::getRangeMap ( ) const
virtual
template<class MatrixType >
bool Ifpack2::Details::Amesos2Wrapper< MatrixType >::hasTransposeApply ( ) const

Whether this object's apply() method can apply the transpose (or conjugate transpose, if applicable).

template<class MatrixType >
Teuchos::RCP< const Teuchos::Comm< int > > Ifpack2::Details::Amesos2Wrapper< MatrixType >::getComm ( ) const

The input matrix's communicator.

template<class MatrixType >
Teuchos::RCP< const typename Amesos2Wrapper< MatrixType >::row_matrix_type > Ifpack2::Details::Amesos2Wrapper< MatrixType >::getMatrix ( ) const
virtual
template<class MatrixType >
int Ifpack2::Details::Amesos2Wrapper< MatrixType >::getNumInitialize ( ) const
virtual
template<class MatrixType >
int Ifpack2::Details::Amesos2Wrapper< MatrixType >::getNumCompute ( ) const
virtual
template<class MatrixType >
int Ifpack2::Details::Amesos2Wrapper< MatrixType >::getNumApply ( ) const
virtual
template<class MatrixType >
double Ifpack2::Details::Amesos2Wrapper< MatrixType >::getInitializeTime ( ) const
virtual
template<class MatrixType >
double Ifpack2::Details::Amesos2Wrapper< MatrixType >::getComputeTime ( ) const
virtual
template<class MatrixType >
double Ifpack2::Details::Amesos2Wrapper< MatrixType >::getApplyTime ( ) const
virtual
template<class MatrixType >
std::string Ifpack2::Details::Amesos2Wrapper< MatrixType >::description ( ) const

A one-line description of this object.

template<class MatrixType >
void Ifpack2::Details::Amesos2Wrapper< MatrixType >::describe ( Teuchos::FancyOStream out,
const Teuchos::EVerbosityLevel  verbLevel = Teuchos::Describable::verbLevel_default 
) const

Print the object with some verbosity level to the given output stream.


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