Stokhos  Development
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Groups Pages
Public Types | List of all members
Belos::StatusTestGenResNorm< Sacado::MP::Vector< Storage >, MV, OP > Class Template Reference
Inheritance diagram for Belos::StatusTestGenResNorm< Sacado::MP::Vector< Storage >, MV, OP >:
Inheritance graph
[legend]
Collaboration diagram for Belos::StatusTestGenResNorm< Sacado::MP::Vector< Storage >, MV, OP >:
Collaboration graph
[legend]

Public Types

typedef Sacado::MP::Vector
< Storage > 
ScalarType
 
typedef Teuchos::ScalarTraits
< ScalarType
SCT
 
typedef SCT::magnitudeType MagnitudeType
 
typedef MultiVecTraits
< ScalarType, MV > 
MVT
 
Enums.
enum  ResType { Implicit, Explicit }
 Select how the residual std::vector is produced. More...
 

Public Member Functions

Constructors/destructors.
 StatusTestGenResNorm (MagnitudeType Tolerance, int quorum=-1, bool showMaxResNormOnly=false)
 Constructor. More...
 
virtual ~StatusTestGenResNorm ()
 Destructor.
 
Form and parameter definition methods.
int defineResForm (ResType TypeOfResidual, NormType TypeOfNorm)
 Define form of the residual, its norm and optional weighting std::vector. More...
 
int defineScaleForm (ScaleType TypeOfScaling, NormType TypeOfNorm, MagnitudeType ScaleValue=Teuchos::ScalarTraits< MagnitudeType >::one())
 Define form of the scaling, its norm, its optional weighting std::vector, or, alternatively, define an explicit value. More...
 
NormType getResNormType ()
 
int setTolerance (MagnitudeType tolerance)
 Set the value of the tolerance. More...
 
int setQuorum (int quorum)
 
int setShowMaxResNormOnly (bool showMaxResNormOnly)
 Set whether the only maximum residual norm is displayed when the print() method is called.
 
Status methods
StatusType checkStatus (Iteration< ScalarType, MV, OP > *iSolver)
 Check convergence status: Passed, Failed, or Undefined. More...
 
StatusType getStatus () const
 Return the result of the most recent CheckStatus call.
 
Reset methods
void reset ()
 Resets the internal configuration to the initial state.
 
Print methods
void print (std::ostream &os, int indent=0) const
 Output formatted description of stopping test to output stream.
 
void printStatus (std::ostream &os, StatusType type) const
 Print message for each status specific to this stopping test.
 
Methods to access data members.
Teuchos::RCP< MV > getSolution ()
 
int getQuorum () const
 
bool getShowMaxResNormOnly ()
 Returns whether the only maximum residual norm is displayed when the print() method is called.
 
std::vector< int > convIndices ()
 Returns the std::vector containing the indices of the residuals that passed the test.
 
MagnitudeType getTolerance () const
 Returns the value of the tolerance, $ \tau $, set in the constructor.
 
const std::vector
< MagnitudeType > * 
getTestValue () const
 Returns the test value, $ \frac{\|r\|}{\sigma} $, computed in most recent call to CheckStatus.
 
const std::vector
< MagnitudeType > * 
getResNormValue () const
 Returns the residual norm value, $ \|r\| $, computed in most recent call to CheckStatus.
 
const std::vector
< MagnitudeType > * 
getScaledNormValue () const
 Returns the scaled norm value, $ \sigma $.
 
bool getLOADetected () const
 
const std::vector< int > getEnsembleIterations () const
 Returns number of ensemble iterations.
 
Misc.
StatusType firstCallCheckStatusSetup (Iteration< ScalarType, MV, OP > *iSolver)
 Call to setup initial scaling std::vector. More...
 
Overridden from Teuchos::Describable
std::string description () const
 Method to return description of the maximum iteration status test.
 

Member Enumeration Documentation

template<class Storage , class MV , class OP >
enum Belos::StatusTestGenResNorm< Sacado::MP::Vector< Storage >, MV, OP >::ResType

Select how the residual std::vector is produced.

Enumerator
Implicit 

Use the residual std::vector produced by the iterative solver.

Explicit 

Explicitly compute the residual std::vector r = b - A*x using the linear problem.

Constructor & Destructor Documentation

template<class Storage , class MV , class OP >
Belos::StatusTestGenResNorm< Sacado::MP::Vector< Storage >, MV, OP >::StatusTestGenResNorm ( MagnitudeType  Tolerance,
int  quorum = -1,
bool  showMaxResNormOnly = false 
)

Constructor.

The constructor takes a single argument specifying the tolerance ( $\tau$). If none of the form definition methods are called, we use $\|r\|_2/\|r^{(0)}\|_2 \le \tau$ as the stopping criterion, where $\|r\|_2$ uses the least costly form of the 2-norm of residual available from the iterative method and $\|r^{(0)}\|_2$ is the corresponding norm of the initial residual. The least costly form of the 2-norm depends on the chosen iterative method. Most Krylov methods produce the preconditioned residual std::vector in a form that would be exact in infinite precision arithmetic. This std::vector may be different from the true residual either because left preconditioning was used, or because round-off error has introduced significant error, or both.

You can also state the number of vectors that must pass the convergence criteria before the status test passes by using the quorum argument.

Member Function Documentation

template<class Storage , class MV , class OP >
StatusType Belos::StatusTestGenResNorm< Sacado::MP::Vector< Storage >, MV, OP >::checkStatus ( Iteration< ScalarType, MV, OP > *  iSolver)

Check convergence status: Passed, Failed, or Undefined.

This method checks to see if the convergence criteria are met. Depending on how the residual test is constructed this method will return the appropriate status type.

Returns
StatusType: Passed, Failed, or Undefined.
template<class Storage , class MV , class OP >
int Belos::StatusTestGenResNorm< Sacado::MP::Vector< Storage >, MV, OP >::defineResForm ( ResType  TypeOfResidual,
NormType  TypeOfNorm 
)

Define form of the residual, its norm and optional weighting std::vector.

This method defines the form of $\|r\|$. We specify:

  • Whether the residual std::vector should be explicitly computed, or taken from the iterative method.
  • The norm to be used on the residual (this may be different than the norm used in DefineScaleForm()).
template<class Storage , class MV , class OP >
int Belos::StatusTestGenResNorm< Sacado::MP::Vector< Storage >, MV, OP >::defineScaleForm ( ScaleType  TypeOfScaling,
NormType  TypeOfNorm,
MagnitudeType  ScaleValue = Teuchos::ScalarTraits< MagnitudeType >::one() 
)

Define form of the scaling, its norm, its optional weighting std::vector, or, alternatively, define an explicit value.

This method defines the form of how the residual is scaled (if at all). It operates in two modes:

  1. User-provided scaling value:

    • Set argument TypeOfScaling to UserProvided.
    • Set ScaleValue to a non-zero value that the residual norm will be divided by.
    • TypeOfNorm argument will be ignored.
    • Sample use: Define ScaleValue = $\|A\|_{\infty}$ where $ A $ is the matrix of the linear problem.

  2. Use a supported Scaling Form:
    • Define TypeOfScaling to be the norm of the right hand side, the initial residual std::vector, or to none.
    • Define norm to be used on the scaling std::vector (this may be different than the norm used in DefineResForm()).
template<class Storage , class MV , class OP >
StatusType Belos::StatusTestGenResNorm< Sacado::MP::Vector< Storage >, MV, OP >::firstCallCheckStatusSetup ( Iteration< ScalarType, MV, OP > *  iSolver)

Call to setup initial scaling std::vector.

After this function is called getScaledNormValue() can be called to get the scaling std::vector.

template<class Storage , class MV , class OP >
bool Belos::StatusTestGenResNorm< Sacado::MP::Vector< Storage >, MV, OP >::getLOADetected ( ) const
inline

Returns a boolean indicating a loss of accuracy has been detected in computing the residual.

Note
This status test does not check for loss of accuracy, so this method will always return false.
template<class Storage , class MV , class OP >
int Belos::StatusTestGenResNorm< Sacado::MP::Vector< Storage >, MV, OP >::getQuorum ( ) const
inline

Returns the number of residuals that must pass the convergence test before Passed is returned.

Note
If quorum=-1 then all residuals must pass the convergence test before Passed is returned.
template<class Storage , class MV , class OP >
Teuchos::RCP<MV> Belos::StatusTestGenResNorm< Sacado::MP::Vector< Storage >, MV, OP >::getSolution ( )
inline

Returns the current solution estimate that was computed for the most recent residual test.

Note
This is useful for explicit residual tests, if this test is an implicit residual test a null pointer will be returned.
template<class Storage , class MV , class OP >
int Belos::StatusTestGenResNorm< Sacado::MP::Vector< Storage >, MV, OP >::setQuorum ( int  quorum)
inline

Sets the number of residuals that must pass the convergence test before Passed is returned.

Note
If quorum=-1 then all residuals must pass the convergence test before Passed is returned.
template<class Storage , class MV , class OP >
int Belos::StatusTestGenResNorm< Sacado::MP::Vector< Storage >, MV, OP >::setTolerance ( MagnitudeType  tolerance)
inline

Set the value of the tolerance.

We allow the tolerance to be reset for cases where, in the process of testing the residual, we find that the initial tolerance was too tight or too lax.


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