Stokhos Package Browser (Single Doxygen Collection)  Version of the Day
Public Types | List of all members
Belos::StatusTestGenResNorm< Sacado::MP::Vector< Storage >, MV, OP > Class Template Reference

#include <Belos_StatusTest_GenResNorm_MP_Vector.hpp>

Inherits StatusTestResNorm< Sacado::MP::Vector< Storage >, MV, OP >.

Public Types

typedef Sacado::MP::Vector< StorageScalarType
 
typedef Teuchos::ScalarTraits< ScalarTypeSCT
 
typedef SCT::magnitudeType MagnitudeType
 
typedef MultiVecTraits< ScalarType, MV > MVT
 

Enums.

enum  ResType { Implicit, Explicit }
 Select how the residual std::vector is produced. More...
 

Constructors/destructors.

 StatusTestGenResNorm (MagnitudeType Tolerance, int quorum=-1, bool showMaxResNormOnly=false)
 Constructor. More...
 
virtual ~StatusTestGenResNorm ()
 Destructor. More...
 

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...
 
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. More...
 

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. More...
 

Reset methods

void reset ()
 Resets the internal configuration to the initial state. More...
 

Print methods

void print (std::ostream &os, int indent=0) const
 Output formatted description of stopping test to output stream. More...
 
void printStatus (std::ostream &os, StatusType type) const
 Print message for each status specific to this stopping test. More...
 

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. More...
 
std::vector< intconvIndices ()
 Returns the std::vector containing the indices of the residuals that passed the test. More...
 
MagnitudeType getTolerance () const
 Returns the value of the tolerance, $ \tau $, set in the constructor. More...
 
const std::vector< MagnitudeType > * getTestValue () const
 Returns the test value, $ \frac{\|r\|}{\sigma} $, computed in most recent call to CheckStatus. More...
 
const std::vector< MagnitudeType > * getResNormValue () const
 Returns the residual norm value, $ \|r\| $, computed in most recent call to CheckStatus. More...
 
const std::vector< MagnitudeType > * getScaledNormValue () const
 Returns the scaled norm value, $ \sigma $. More...
 
bool getLOADetected () const
 
const std::vector< intgetEnsembleIterations () const
 Returns number of ensemble iterations. More...
 

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. More...
 

Private methods.

std::string resFormStr () const
 Description of current residual form. More...
 

Private data members.

MagnitudeType tolerance_
 Tolerance used to determine convergence. More...
 
int quorum_
 Number of residuals that must pass the convergence test before Passed is returned. More...
 
bool showMaxResNormOnly_
 Determines if the entries for all of the residuals are shown or just the max. More...
 
ResType restype_
 Type of residual to use (explicit or implicit) More...
 
NormType resnormtype_
 Type of norm to use on residual (OneNorm, TwoNorm, or InfNorm). More...
 
ScaleType scaletype_
 Type of scaling to use (Norm of RHS, Norm of Initial Residual, None or User provided) More...
 
NormType scalenormtype_
 Type of norm to use on the scaling (OneNorm, TwoNorm, or InfNorm) More...
 
MagnitudeType scalevalue_
 Scaling value. More...
 
std::vector< MagnitudeTypescalevector_
 Scaling std::vector. More...
 
std::vector< MagnitudeTyperesvector_
 Residual norm std::vector. More...
 
std::vector< MagnitudeTypetestvector_
 Test std::vector = resvector_ / scalevector_. More...
 
std::vector< intind_
 Vector containing the indices for the vectors that passed the test. More...
 
Teuchos::RCP< MV > curSoln_
 Most recent solution vector used by this status test. More...
 
StatusType status_
 Status. More...
 
int curBlksz_
 The current blocksize of the linear system being solved. More...
 
int curNumRHS_
 The current number of right-hand sides being solved for. More...
 
std::vector< intcurLSIdx_
 The indices of the current number of right-hand sides being solved for. More...
 
int curLSNum_
 The current number of linear systems that have been loaded into the linear problem. More...
 
int numrhs_
 The total number of right-hand sides being solved for. More...
 
bool firstcallCheckStatus_
 Is this the first time CheckStatus is called? More...
 
bool firstcallDefineResForm_
 Is this the first time DefineResForm is called? More...
 
bool firstcallDefineScaleForm_
 Is this the first time DefineScaleForm is called? More...
 
std::vector< intensemble_converged
 Which ensemble components have converged. More...
 
std::vector< intensemble_iterations
 The number of iterations at which point each ensemble component converges. More...
 

Detailed Description

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

Definition at line 85 of file Belos_StatusTest_GenResNorm_MP_Vector.hpp.

Member Typedef Documentation

◆ ScalarType

template<class Storage , class MV , class OP >
typedef Sacado::MP::Vector<Storage> Belos::StatusTestGenResNorm< Sacado::MP::Vector< Storage >, MV, OP >::ScalarType

Definition at line 91 of file Belos_StatusTest_GenResNorm_MP_Vector.hpp.

◆ SCT

template<class Storage , class MV , class OP >
typedef Teuchos::ScalarTraits<ScalarType> Belos::StatusTestGenResNorm< Sacado::MP::Vector< Storage >, MV, OP >::SCT

Definition at line 92 of file Belos_StatusTest_GenResNorm_MP_Vector.hpp.

◆ MagnitudeType

template<class Storage , class MV , class OP >
typedef SCT::magnitudeType Belos::StatusTestGenResNorm< Sacado::MP::Vector< Storage >, MV, OP >::MagnitudeType

Definition at line 93 of file Belos_StatusTest_GenResNorm_MP_Vector.hpp.

◆ MVT

template<class Storage , class MV , class OP >
typedef MultiVecTraits<ScalarType,MV> Belos::StatusTestGenResNorm< Sacado::MP::Vector< Storage >, MV, OP >::MVT

Definition at line 94 of file Belos_StatusTest_GenResNorm_MP_Vector.hpp.

Member Enumeration Documentation

◆ ResType

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.

Definition at line 102 of file Belos_StatusTest_GenResNorm_MP_Vector.hpp.

Constructor & Destructor Documentation

◆ StatusTestGenResNorm()

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 scaling or 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.

◆ ~StatusTestGenResNorm()

template<class Storage , class MV , class OP >
virtual Belos::StatusTestGenResNorm< Sacado::MP::Vector< Storage >, MV, OP >::~StatusTestGenResNorm ( )
virtual

Destructor.

Member Function Documentation

◆ defineResForm()

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()).

◆ 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()).

◆ setTolerance()

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.

Definition at line 171 of file Belos_StatusTest_GenResNorm_MP_Vector.hpp.

◆ setQuorum()

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.

Definition at line 175 of file Belos_StatusTest_GenResNorm_MP_Vector.hpp.

◆ setShowMaxResNormOnly()

template<class Storage , class MV , class OP >
int Belos::StatusTestGenResNorm< Sacado::MP::Vector< Storage >, MV, OP >::setShowMaxResNormOnly ( bool  showMaxResNormOnly)
inline

Set whether the only maximum residual norm is displayed when the print() method is called.

Definition at line 178 of file Belos_StatusTest_GenResNorm_MP_Vector.hpp.

◆ checkStatus()

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.

◆ getStatus()

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

Return the result of the most recent CheckStatus call.

Definition at line 194 of file Belos_StatusTest_GenResNorm_MP_Vector.hpp.

◆ reset()

template<class Storage , class MV , class OP >
void Belos::StatusTestGenResNorm< Sacado::MP::Vector< Storage >, MV, OP >::reset ( )

Resets the internal configuration to the initial state.

◆ print()

template<class Storage , class MV , class OP >
void Belos::StatusTestGenResNorm< Sacado::MP::Vector< Storage >, MV, OP >::print ( std::ostream &  os,
int  indent = 0 
) const

Output formatted description of stopping test to output stream.

◆ printStatus()

template<class Storage , class MV , class OP >
void Belos::StatusTestGenResNorm< Sacado::MP::Vector< Storage >, MV, OP >::printStatus ( std::ostream &  os,
StatusType  type 
) const

Print message for each status specific to this stopping test.

◆ getSolution()

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.

Definition at line 221 of file Belos_StatusTest_GenResNorm_MP_Vector.hpp.

◆ getQuorum()

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.

Definition at line 225 of file Belos_StatusTest_GenResNorm_MP_Vector.hpp.

◆ getShowMaxResNormOnly()

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

Returns whether the only maximum residual norm is displayed when the print() method is called.

Definition at line 228 of file Belos_StatusTest_GenResNorm_MP_Vector.hpp.

◆ convIndices()

template<class Storage , class MV , class OP >
std::vector<int> Belos::StatusTestGenResNorm< Sacado::MP::Vector< Storage >, MV, OP >::convIndices ( )
inline

Returns the std::vector containing the indices of the residuals that passed the test.

Definition at line 231 of file Belos_StatusTest_GenResNorm_MP_Vector.hpp.

◆ getTolerance()

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

Returns the value of the tolerance, $ \tau $, set in the constructor.

Definition at line 234 of file Belos_StatusTest_GenResNorm_MP_Vector.hpp.

◆ getTestValue()

template<class Storage , class MV , class OP >
const std::vector<MagnitudeType>* Belos::StatusTestGenResNorm< Sacado::MP::Vector< Storage >, MV, OP >::getTestValue ( ) const
inline

Returns the test value, $ \frac{\|r\|}{\sigma} $, computed in most recent call to CheckStatus.

Definition at line 237 of file Belos_StatusTest_GenResNorm_MP_Vector.hpp.

◆ getResNormValue()

template<class Storage , class MV , class OP >
const std::vector<MagnitudeType>* Belos::StatusTestGenResNorm< Sacado::MP::Vector< Storage >, MV, OP >::getResNormValue ( ) const
inline

Returns the residual norm value, $ \|r\| $, computed in most recent call to CheckStatus.

Definition at line 240 of file Belos_StatusTest_GenResNorm_MP_Vector.hpp.

◆ getScaledNormValue()

template<class Storage , class MV , class OP >
const std::vector<MagnitudeType>* Belos::StatusTestGenResNorm< Sacado::MP::Vector< Storage >, MV, OP >::getScaledNormValue ( ) const
inline

Returns the scaled norm value, $ \sigma $.

Definition at line 243 of file Belos_StatusTest_GenResNorm_MP_Vector.hpp.

◆ getLOADetected()

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.

Definition at line 247 of file Belos_StatusTest_GenResNorm_MP_Vector.hpp.

◆ getEnsembleIterations()

template<class Storage , class MV , class OP >
const std::vector<int> Belos::StatusTestGenResNorm< Sacado::MP::Vector< Storage >, MV, OP >::getEnsembleIterations ( ) const
inline

Returns number of ensemble iterations.

Definition at line 250 of file Belos_StatusTest_GenResNorm_MP_Vector.hpp.

◆ firstCallCheckStatusSetup()

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.

◆ description()

template<class Storage , class MV , class OP >
std::string Belos::StatusTestGenResNorm< Sacado::MP::Vector< Storage >, MV, OP >::description ( void  ) const
inline

Method to return description of the maximum iteration status test.

Definition at line 270 of file Belos_StatusTest_GenResNorm_MP_Vector.hpp.

◆ resFormStr()

template<class Storage , class MV , class OP >
std::string Belos::StatusTestGenResNorm< Sacado::MP::Vector< Storage >, MV, OP >::resFormStr ( ) const
inlineprivate

Description of current residual form.

Definition at line 286 of file Belos_StatusTest_GenResNorm_MP_Vector.hpp.

Member Data Documentation

◆ tolerance_

template<class Storage , class MV , class OP >
MagnitudeType Belos::StatusTestGenResNorm< Sacado::MP::Vector< Storage >, MV, OP >::tolerance_
private

Tolerance used to determine convergence.

Definition at line 325 of file Belos_StatusTest_GenResNorm_MP_Vector.hpp.

◆ quorum_

template<class Storage , class MV , class OP >
int Belos::StatusTestGenResNorm< Sacado::MP::Vector< Storage >, MV, OP >::quorum_
private

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

Definition at line 328 of file Belos_StatusTest_GenResNorm_MP_Vector.hpp.

◆ showMaxResNormOnly_

template<class Storage , class MV , class OP >
bool Belos::StatusTestGenResNorm< Sacado::MP::Vector< Storage >, MV, OP >::showMaxResNormOnly_
private

Determines if the entries for all of the residuals are shown or just the max.

Definition at line 331 of file Belos_StatusTest_GenResNorm_MP_Vector.hpp.

◆ restype_

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

Type of residual to use (explicit or implicit)

Definition at line 334 of file Belos_StatusTest_GenResNorm_MP_Vector.hpp.

◆ resnormtype_

template<class Storage , class MV , class OP >
NormType Belos::StatusTestGenResNorm< Sacado::MP::Vector< Storage >, MV, OP >::resnormtype_
private

Type of norm to use on residual (OneNorm, TwoNorm, or InfNorm).

Definition at line 337 of file Belos_StatusTest_GenResNorm_MP_Vector.hpp.

◆ scaletype_

template<class Storage , class MV , class OP >
ScaleType Belos::StatusTestGenResNorm< Sacado::MP::Vector< Storage >, MV, OP >::scaletype_
private

Type of scaling to use (Norm of RHS, Norm of Initial Residual, None or User provided)

Definition at line 340 of file Belos_StatusTest_GenResNorm_MP_Vector.hpp.

◆ scalenormtype_

template<class Storage , class MV , class OP >
NormType Belos::StatusTestGenResNorm< Sacado::MP::Vector< Storage >, MV, OP >::scalenormtype_
private

Type of norm to use on the scaling (OneNorm, TwoNorm, or InfNorm)

Definition at line 343 of file Belos_StatusTest_GenResNorm_MP_Vector.hpp.

◆ scalevalue_

template<class Storage , class MV , class OP >
MagnitudeType Belos::StatusTestGenResNorm< Sacado::MP::Vector< Storage >, MV, OP >::scalevalue_
private

Scaling value.

Definition at line 346 of file Belos_StatusTest_GenResNorm_MP_Vector.hpp.

◆ scalevector_

template<class Storage , class MV , class OP >
std::vector<MagnitudeType> Belos::StatusTestGenResNorm< Sacado::MP::Vector< Storage >, MV, OP >::scalevector_
private

Scaling std::vector.

Definition at line 349 of file Belos_StatusTest_GenResNorm_MP_Vector.hpp.

◆ resvector_

template<class Storage , class MV , class OP >
std::vector<MagnitudeType> Belos::StatusTestGenResNorm< Sacado::MP::Vector< Storage >, MV, OP >::resvector_
private

Residual norm std::vector.

Definition at line 352 of file Belos_StatusTest_GenResNorm_MP_Vector.hpp.

◆ testvector_

template<class Storage , class MV , class OP >
std::vector<MagnitudeType> Belos::StatusTestGenResNorm< Sacado::MP::Vector< Storage >, MV, OP >::testvector_
private

Test std::vector = resvector_ / scalevector_.

Definition at line 355 of file Belos_StatusTest_GenResNorm_MP_Vector.hpp.

◆ ind_

template<class Storage , class MV , class OP >
std::vector<int> Belos::StatusTestGenResNorm< Sacado::MP::Vector< Storage >, MV, OP >::ind_
private

Vector containing the indices for the vectors that passed the test.

Definition at line 358 of file Belos_StatusTest_GenResNorm_MP_Vector.hpp.

◆ curSoln_

template<class Storage , class MV , class OP >
Teuchos::RCP<MV> Belos::StatusTestGenResNorm< Sacado::MP::Vector< Storage >, MV, OP >::curSoln_
private

Most recent solution vector used by this status test.

Definition at line 361 of file Belos_StatusTest_GenResNorm_MP_Vector.hpp.

◆ status_

template<class Storage , class MV , class OP >
StatusType Belos::StatusTestGenResNorm< Sacado::MP::Vector< Storage >, MV, OP >::status_
private

Status.

Definition at line 364 of file Belos_StatusTest_GenResNorm_MP_Vector.hpp.

◆ curBlksz_

template<class Storage , class MV , class OP >
int Belos::StatusTestGenResNorm< Sacado::MP::Vector< Storage >, MV, OP >::curBlksz_
private

The current blocksize of the linear system being solved.

Definition at line 367 of file Belos_StatusTest_GenResNorm_MP_Vector.hpp.

◆ curNumRHS_

template<class Storage , class MV , class OP >
int Belos::StatusTestGenResNorm< Sacado::MP::Vector< Storage >, MV, OP >::curNumRHS_
private

The current number of right-hand sides being solved for.

Definition at line 370 of file Belos_StatusTest_GenResNorm_MP_Vector.hpp.

◆ curLSIdx_

template<class Storage , class MV , class OP >
std::vector<int> Belos::StatusTestGenResNorm< Sacado::MP::Vector< Storage >, MV, OP >::curLSIdx_
private

The indices of the current number of right-hand sides being solved for.

Definition at line 373 of file Belos_StatusTest_GenResNorm_MP_Vector.hpp.

◆ curLSNum_

template<class Storage , class MV , class OP >
int Belos::StatusTestGenResNorm< Sacado::MP::Vector< Storage >, MV, OP >::curLSNum_
private

The current number of linear systems that have been loaded into the linear problem.

Definition at line 376 of file Belos_StatusTest_GenResNorm_MP_Vector.hpp.

◆ numrhs_

template<class Storage , class MV , class OP >
int Belos::StatusTestGenResNorm< Sacado::MP::Vector< Storage >, MV, OP >::numrhs_
private

The total number of right-hand sides being solved for.

Definition at line 379 of file Belos_StatusTest_GenResNorm_MP_Vector.hpp.

◆ firstcallCheckStatus_

template<class Storage , class MV , class OP >
bool Belos::StatusTestGenResNorm< Sacado::MP::Vector< Storage >, MV, OP >::firstcallCheckStatus_
private

Is this the first time CheckStatus is called?

Definition at line 382 of file Belos_StatusTest_GenResNorm_MP_Vector.hpp.

◆ firstcallDefineResForm_

template<class Storage , class MV , class OP >
bool Belos::StatusTestGenResNorm< Sacado::MP::Vector< Storage >, MV, OP >::firstcallDefineResForm_
private

Is this the first time DefineResForm is called?

Definition at line 385 of file Belos_StatusTest_GenResNorm_MP_Vector.hpp.

◆ firstcallDefineScaleForm_

template<class Storage , class MV , class OP >
bool Belos::StatusTestGenResNorm< Sacado::MP::Vector< Storage >, MV, OP >::firstcallDefineScaleForm_
private

Is this the first time DefineScaleForm is called?

Definition at line 388 of file Belos_StatusTest_GenResNorm_MP_Vector.hpp.

◆ ensemble_converged

template<class Storage , class MV , class OP >
std::vector<int> Belos::StatusTestGenResNorm< Sacado::MP::Vector< Storage >, MV, OP >::ensemble_converged
private

Which ensemble components have converged.

Definition at line 391 of file Belos_StatusTest_GenResNorm_MP_Vector.hpp.

◆ ensemble_iterations

template<class Storage , class MV , class OP >
std::vector<int> Belos::StatusTestGenResNorm< Sacado::MP::Vector< Storage >, MV, OP >::ensemble_iterations
private

The number of iterations at which point each ensemble component converges.

Definition at line 394 of file Belos_StatusTest_GenResNorm_MP_Vector.hpp.


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