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

Wrapper for iterative linear solvers (e.g., CG or GMRES). More...

#include <Ifpack2_Krylov_decl.hpp>

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

Public Types

typedef MatrixType::scalar_type scalar_type
 The type of the entries of the input MatrixType. More...
 
typedef BelosScalarType< scalar_type >::type belos_scalar_type
 The scalar type used by Belos (which may not be scalar_type) 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_typerow_matrix_type
 Type of the Tpetra::RowMatrix specialization that this class uses. More...
 
typedef Ifpack2::Preconditioner< scalar_type, local_ordinal_type, global_ordinal_type, node_typeprec_type
 Type of the Ifpack2::Preconditioner specialization from which this class inherits. 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

 Krylov (const Teuchos::RCP< const row_matrix_type > &A)
 Constructor that takes a Tpetra::RowMatrix. More...
 
virtual ~Krylov ()
 Destructor. More...
 
Methods for setting parameters and initialization
void setParameters (const Teuchos::ParameterList &params)
 Set the preconditioner's parameters. More...
 
void initialize ()
 Do any initialization that depends on the input matrix's structure. More...
 
bool isInitialized () const
 Return true if initialize() completed successfully, else false. More...
 
void compute ()
 Do any initialization that depends on the input matrix's values. More...
 
bool isComputed () const
 Return 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, putting the result in Y. More...
 
Teuchos::RCP< const Tpetra::Map< local_ordinal_type, global_ordinal_type, node_type > > getDomainMap () const
 Tpetra::Map representing the domain of this operator. More...
 
Teuchos::RCP< const Tpetra::Map< local_ordinal_type, global_ordinal_type, node_type > > getRangeMap () 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
 Return the operator's communicator. More...
 
Teuchos::RCP< const Tpetra::RowMatrix< scalar_type, local_ordinal_type, global_ordinal_type, node_type > > getMatrix () const
 Returns a reference to the matrix to be preconditioned. More...
 
int getNumInitialize () const
 Returns the number of calls to Initialize(). More...
 
int getNumCompute () const
 Returns the number of calls to Compute(). More...
 
int getNumApply () const
 Returns the number of calls to apply(). More...
 
double getInitializeTime () const
 Returns the time spent in Initialize(). More...
 
double getComputeTime () const
 Returns the time spent in Compute(). More...
 
double getApplyTime () const
 Returns the time spent in apply(). More...
 
Overridden from Teuchos::Describable
std::string description () const
 Return a simple 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 an FancyOStream object. 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::Krylov< MatrixType >

Wrapper for iterative linear solvers (e.g., CG or GMRES).

Template Parameters
MatrixTypeA specialization of Tpetra::RowMatrix.
Warning
This class has been DEPRECATED. DO NOT USE THIS CLASS. IT MAY GO AWAY AT ANY TIME.

Krylov computes a few iterations of CG or GMRES with zero initial guess as a smoother for a given Tpetra::RowMatrix.

For a list of all run-time parameters that this class accepts, see the documentation of setParameters().

Member Typedef Documentation

template<class MatrixType>
typedef MatrixType::scalar_type Ifpack2::Krylov< MatrixType >::scalar_type

The type of the entries of the input MatrixType.

template<class MatrixType>
typedef BelosScalarType<scalar_type>::type Ifpack2::Krylov< MatrixType >::belos_scalar_type

The scalar type used by Belos (which may not be scalar_type)

template<class MatrixType>
typedef MatrixType::local_ordinal_type Ifpack2::Krylov< MatrixType >::local_ordinal_type

The type of local indices in the input MatrixType.

template<class MatrixType>
typedef MatrixType::global_ordinal_type Ifpack2::Krylov< MatrixType >::global_ordinal_type

The type of global indices in the input MatrixType.

template<class MatrixType>
typedef MatrixType::node_type Ifpack2::Krylov< MatrixType >::node_type

The Node type used by the input MatrixType.

template<class MatrixType>
typedef Teuchos::ScalarTraits<scalar_type>::magnitudeType Ifpack2::Krylov< 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::Krylov< MatrixType >::row_matrix_type

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

Type of the Ifpack2::Preconditioner specialization from which this class inherits.

Constructor & Destructor Documentation

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

Constructor that takes a Tpetra::RowMatrix.

template<class MatrixType >
Ifpack2::Krylov< MatrixType >::~Krylov ( )
virtual

Destructor.

Member Function Documentation

template<class MatrixType >
void Ifpack2::Krylov< MatrixType >::setParameters ( const Teuchos::ParameterList &  params)
virtual

Set the preconditioner's parameters.

This preconditioner accepts the following parameters:

  • "krylov: iteration type" (std::string)
  • "krylov: number of iterations" (int)
  • "krylov: residual tolerance" (magnitude_type)

The "krylov: iteration type" parameter specifies the name of the iterative linear solver to use.

Note: Because some of the iterative solvers in Belos are not currently supported for complex types, the BelosSolverFactory is not used; Ifpack2::Krylov either uses Block GMRES or Block CG.

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

template<class MatrixType >
void Ifpack2::Krylov< MatrixType >::initialize ( )
virtual
template<class MatrixType>
bool Ifpack2::Krylov< MatrixType >::isInitialized ( ) const
inlinevirtual
template<class MatrixType >
void Ifpack2::Krylov< MatrixType >::compute ( )
virtual
template<class MatrixType>
bool Ifpack2::Krylov< MatrixType >::isComputed ( ) const
inlinevirtual
template<class MatrixType >
void Ifpack2::Krylov< MatrixType >::setMatrix ( const Teuchos::RCP< const row_matrix_type > &  A)
virtual

Change the matrix to be preconditioned.

Parameters
[in]AThe 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::Krylov< 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
template<class MatrixType >
Teuchos::RCP< const Tpetra::Map< typename MatrixType::local_ordinal_type, typename MatrixType::global_ordinal_type, typename MatrixType::node_type > > Ifpack2::Krylov< MatrixType >::getDomainMap ( ) const
virtual
template<class MatrixType >
Teuchos::RCP< const Tpetra::Map< typename MatrixType::local_ordinal_type, typename MatrixType::global_ordinal_type, typename MatrixType::node_type > > Ifpack2::Krylov< MatrixType >::getRangeMap ( ) const
virtual
template<class MatrixType >
bool Ifpack2::Krylov< 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::Krylov< MatrixType >::getComm ( ) const

Return the operator's communicator.

template<class MatrixType >
Teuchos::RCP< const Tpetra::RowMatrix< typename MatrixType::scalar_type, typename MatrixType::local_ordinal_type, typename MatrixType::global_ordinal_type, typename MatrixType::node_type > > Ifpack2::Krylov< MatrixType >::getMatrix ( ) const
virtual
template<class MatrixType >
int Ifpack2::Krylov< MatrixType >::getNumInitialize ( ) const
virtual
template<class MatrixType >
int Ifpack2::Krylov< MatrixType >::getNumCompute ( ) const
virtual
template<class MatrixType >
int Ifpack2::Krylov< MatrixType >::getNumApply ( ) const
virtual
template<class MatrixType >
double Ifpack2::Krylov< MatrixType >::getInitializeTime ( ) const
virtual
template<class MatrixType >
double Ifpack2::Krylov< MatrixType >::getComputeTime ( ) const
virtual
template<class MatrixType >
double Ifpack2::Krylov< MatrixType >::getApplyTime ( ) const
virtual
template<class MatrixType >
std::string Ifpack2::Krylov< MatrixType >::description ( ) const

Return a simple one-line description of this object.

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

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


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