Belos Package Browser (Single Doxygen Collection)  Development
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Groups Pages
Private Types | Private Member Functions | Private Attributes | Static Private Attributes | List of all members
Belos::PCPGSolMgr< ScalarType, MV, OP, true > Class Template Reference

#include <BelosPCPGSolMgr.hpp>

Inheritance diagram for Belos::PCPGSolMgr< ScalarType, MV, OP, true >:
Inheritance graph
[legend]

Private Types

typedef MultiVecTraits
< ScalarType, MV > 
MVT
 
typedef OperatorTraits
< ScalarType, MV, OP > 
OPT
 
typedef Teuchos::ScalarTraits
< ScalarType > 
SCT
 
typedef Teuchos::ScalarTraits
< ScalarType >::magnitudeType 
MagnitudeType
 
typedef Teuchos::ScalarTraits
< MagnitudeType
MT
 

Private Member Functions

int ARRQR (int numVecs, int numOrthVecs, const Teuchos::SerialDenseMatrix< int, ScalarType > &D)
 

Private Attributes

Teuchos::RCP< LinearProblem
< ScalarType, MV, OP > > 
problem_
 
Teuchos::RCP< OutputManager
< ScalarType > > 
printer_
 
Teuchos::RCP< std::ostream > outputStream_
 
Teuchos::RCP< StatusTest
< ScalarType, MV, OP > > 
sTest_
 
Teuchos::RCP
< StatusTestMaxIters
< ScalarType, MV, OP > > 
maxIterTest_
 
Teuchos::RCP
< StatusTestGenResNorm
< ScalarType, MV, OP > > 
convTest_
 
Teuchos::RCP< StatusTestOutput
< ScalarType, MV, OP > > 
outputTest_
 
Teuchos::RCP< MatOrthoManager
< ScalarType, MV, OP > > 
ortho_
 
Teuchos::RCP
< Teuchos::ParameterList
params_
 
MagnitudeType convtol_
 Convergence tolerance (read from parameter list). More...
 
MagnitudeType orthoKappa_
 Orthogonalization parameter (read from parameter list). More...
 
MagnitudeType achievedTol_
 Tolerance achieved by the last solve() invocation. More...
 
int numIters_
 Number of iterations taken by the last solve() invocation. More...
 
int maxIters_
 Maximum iteration count (read from parameter list). More...
 
int deflatedBlocks_
 
int savedBlocks_
 
int verbosity_
 
int outputStyle_
 
int outputFreq_
 
std::string orthoType_
 
Teuchos::RCP< MV > U_
 
Teuchos::RCP< MV > C_
 
Teuchos::RCP< MV > R_
 
int dimU_
 
std::string label_
 
Teuchos::RCP< Teuchos::TimetimerSolve_
 
bool isSet_
 

Static Private Attributes

static constexpr int maxIters_default_ = 1000
 
static constexpr int deflatedBlocks_default_ = 2
 
static constexpr int savedBlocks_default_ = 16
 
static constexpr int verbosity_default_ = Belos::Errors
 
static constexpr int outputStyle_default_ = Belos::General
 
static constexpr int outputFreq_default_ = -1
 
static constexpr const char * label_default_ = "Belos"
 
static constexpr const char * orthoType_default_ = "ICGS"
 
static constexpr std::ostream * outputStream_default_ = &std::cout
 

Constructors/Destructor

 PCPGSolMgr ()
 Empty constructor for PCPGSolMgr. This constructor takes no arguments and sets the default values for the solver. The linear problem must be passed in using setProblem() before solve() is called on this object. In most instances, LinearProblem setProblem(...) methods are used. Solver values may be changed using setParameters(). More...
 
 PCPGSolMgr (const Teuchos::RCP< LinearProblem< ScalarType, MV, OP > > &problem, const Teuchos::RCP< Teuchos::ParameterList > &pl)
 Basic constructor for PCPGSolMgr. The constructor accepts a LinearProblem to be solved and a parameter list of these options: More...
 
virtual ~PCPGSolMgr ()
 Destructor. More...
 
virtual Teuchos::RCP
< SolverManager< ScalarType,
MV, OP > > 
clone () const
 clone for Inverted Injection (DII) More...
 

Accessor methods

const LinearProblem
< ScalarType, MV, OP > & 
getProblem () const
 Get current linear problem being solved for in this object. More...
 
Teuchos::RCP< const
Teuchos::ParameterList
getValidParameters () const
 Get a parameter list containing the valid parameters for this object. More...
 
Teuchos::RCP< const
Teuchos::ParameterList
getCurrentParameters () const
 Get a parameter list containing the current parameters for this object. More...
 
Teuchos::Array< Teuchos::RCP
< Teuchos::Time > > 
getTimers () const
 Return the timers for this object. More...
 
MagnitudeType achievedTol () const
 Tolerance achieved by the last solve() invocation. More...
 
int getNumIters () const
 Get the iteration count for the most recent call to solve(). More...
 
bool isLOADetected () const
 Return whether a loss of accuracy was detected by this solver during the most current solve. More...
 

Set methods

void setProblem (const Teuchos::RCP< LinearProblem< ScalarType, MV, OP > > &problem)
 Set the linear problem that needs to be solved. More...
 
void setParameters (const Teuchos::RCP< Teuchos::ParameterList > &params)
 Set the parameters the solver manager should use to solve the linear problem. More...
 

Reset methods

void reset (const ResetType type)
 Performs a reset of the solver manager specified by the ResetType. This informs the solver manager that the solver should prepare for the next call to solve by resetting certain elements of the iterative solver strategy. More...
 

Solver application methods

ReturnType solve ()
 The method either solves the problem or decides to quit. On each call, a (possibly null) seed space is used to accelerate convergence. More...
 

Overridden from Teuchos::Describable

std::string description () const
 Method to return description of the PCPG solver manager. More...
 

Additional Inherited Members

- Public Member Functions inherited from Belos::Details::SolverManagerRequiresRealLapack< ScalarType, MV, OP, true >
 SolverManagerRequiresRealLapack ()
 
virtual ~SolverManagerRequiresRealLapack ()
 
- Public Member Functions inherited from Belos::SolverManager< ScalarType, MV, OP >
 SolverManager ()
 Empty constructor. More...
 
virtual ~SolverManager ()
 Destructor. More...
 
virtual void setUserConvStatusTest (const Teuchos::RCP< StatusTest< ScalarType, MV, OP > > &, const typename StatusTestCombo< ScalarType, MV, OP >::ComboType &=StatusTestCombo< ScalarType, MV, OP >::SEQ)
 Set user-defined convergence status test. More...
 
virtual void setDebugStatusTest (const Teuchos::RCP< StatusTest< ScalarType, MV, OP > > &)
 Set user-defined debug status test. More...
 
- Public Member Functions inherited from Teuchos::Describable
DescribableStreamManipulatorState describe (const Describable &describable, const EVerbosityLevel verbLevel=Describable::verbLevel_default)
 
std::ostream & operator<< (std::ostream &os, const DescribableStreamManipulatorState &d)
 
virtual void describe (FancyOStream &out, const EVerbosityLevel verbLevel=verbLevel_default) const
 
void describe (std::ostream &out, const EVerbosityLevel verbLevel=verbLevel_default) const
 
virtual ~Describable ()
 
 LabeledObject ()
 
virtual ~LabeledObject ()
 
virtual void setObjectLabel (const std::string &objectLabel)
 
virtual std::string getObjectLabel () const
 
- Static Public Attributes inherited from Teuchos::Describable
static const EVerbosityLevel verbLevel_default
 

Detailed Description

template<class ScalarType, class MV, class OP>
class Belos::PCPGSolMgr< ScalarType, MV, OP, true >

Definition at line 181 of file BelosPCPGSolMgr.hpp.

Member Typedef Documentation

template<class ScalarType , class MV , class OP >
typedef MultiVecTraits<ScalarType,MV> Belos::PCPGSolMgr< ScalarType, MV, OP, true >::MVT
private

Definition at line 184 of file BelosPCPGSolMgr.hpp.

template<class ScalarType , class MV , class OP >
typedef OperatorTraits<ScalarType,MV,OP> Belos::PCPGSolMgr< ScalarType, MV, OP, true >::OPT
private

Definition at line 185 of file BelosPCPGSolMgr.hpp.

template<class ScalarType , class MV , class OP >
typedef Teuchos::ScalarTraits<ScalarType> Belos::PCPGSolMgr< ScalarType, MV, OP, true >::SCT
private

Definition at line 186 of file BelosPCPGSolMgr.hpp.

template<class ScalarType , class MV , class OP >
typedef Teuchos::ScalarTraits<ScalarType>::magnitudeType Belos::PCPGSolMgr< ScalarType, MV, OP, true >::MagnitudeType
private

Definition at line 187 of file BelosPCPGSolMgr.hpp.

template<class ScalarType , class MV , class OP >
typedef Teuchos::ScalarTraits<MagnitudeType> Belos::PCPGSolMgr< ScalarType, MV, OP, true >::MT
private

Definition at line 188 of file BelosPCPGSolMgr.hpp.

Constructor & Destructor Documentation

template<class ScalarType , class MV , class OP >
Belos::PCPGSolMgr< ScalarType, MV, OP, true >::PCPGSolMgr ( )

Empty constructor for PCPGSolMgr. This constructor takes no arguments and sets the default values for the solver. The linear problem must be passed in using setProblem() before solve() is called on this object. In most instances, LinearProblem setProblem(...) methods are used. Solver values may be changed using setParameters().

Definition at line 422 of file BelosPCPGSolMgr.hpp.

template<class ScalarType , class MV , class OP >
Belos::PCPGSolMgr< ScalarType, MV, OP, true >::PCPGSolMgr ( const Teuchos::RCP< LinearProblem< ScalarType, MV, OP > > &  problem,
const Teuchos::RCP< Teuchos::ParameterList > &  pl 
)

Basic constructor for PCPGSolMgr. The constructor accepts a LinearProblem to be solved and a parameter list of these options:

  • "Num Deflated Blocks" - a int specifying the number of blocks deflated from the linear system. Default: 2 The parameter distinguishes PCPG from CG.
  • "Num Saved Blocks" - a int specifying the maximum number of blocks saved from old Krylov bases. Default: 16 The parameter distinguishes PCPG from CG.
  • "Block Size" - an int specifying the block size to be used by the underlying block conjugate-gradient solver. In PCPC block size = one. Many parameters are meaningless in the unit block size case. Default: 1
  • "Adaptive Block Size" - a bool specifying whether the block size can be modified throughout the solve. Default: true Meaningless with unit block size
  • "Maximum Iterations" - an int specifying the maximum number of iterations the underlying solver is allowed to perform. Default: 1000
  • "Convergence Tolerance" - a MagnitudeType specifying the level that residual norms must reach to decide convergence. Default: 1e-8.
  • "Orthogonalization" - a string specifying the desired orthogonalization: DGKS, ICGS, IMGS. Default: "ICGS" Meaningless with unit block size
  • "Orthogonalization Constant" - a MagnitudeType used by DGKS orthogonalization to determine whether another step of classical Gram-Schmidt is necessary. Default: -1 (use DGKS default) Meaningless with unit block size
  • "Verbosity" - a sum of MsgType specifying the verbosity. Default: Belos::Errors
  • "Output Style" - a OutputType specifying the style of output. Default: Belos::General
  • "Output Stream" - a reference-counted pointer to the output stream where all solver output is sent. Default: Teuchos::rcp(&std::cout,false)
  • "Output Frequency" - an int specifying how often convergence information should be outputted. Default: -1 (never)
  • "Show Maximum Residual Norm Only" - a bool specifying whether that only the maximum relative residual norm is printed if convergence information is printed. Default: false Meaningless with unit block size
  • "Timer Label" - a std::string to use as a prefix for the timer labels. Default: "Belos"

Definition at line 443 of file BelosPCPGSolMgr.hpp.

template<class ScalarType , class MV , class OP >
virtual Belos::PCPGSolMgr< ScalarType, MV, OP, true >::~PCPGSolMgr ( )
inlinevirtual

Destructor.

Definition at line 241 of file BelosPCPGSolMgr.hpp.

Member Function Documentation

template<class ScalarType , class MV , class OP >
virtual Teuchos::RCP<SolverManager<ScalarType, MV, OP> > Belos::PCPGSolMgr< ScalarType, MV, OP, true >::clone ( ) const
inlinevirtual

clone for Inverted Injection (DII)

Implements Belos::SolverManager< ScalarType, MV, OP >.

Definition at line 244 of file BelosPCPGSolMgr.hpp.

template<class ScalarType , class MV , class OP >
const LinearProblem<ScalarType,MV,OP>& Belos::PCPGSolMgr< ScalarType, MV, OP, true >::getProblem ( ) const
inlinevirtual

Get current linear problem being solved for in this object.

Implements Belos::SolverManager< ScalarType, MV, OP >.

Definition at line 254 of file BelosPCPGSolMgr.hpp.

template<class ScalarType , class MV , class OP >
Teuchos::RCP< const Teuchos::ParameterList > Belos::PCPGSolMgr< ScalarType, MV, OP, true >::getValidParameters ( ) const
virtual

Get a parameter list containing the valid parameters for this object.

Implements Belos::SolverManager< ScalarType, MV, OP >.

Definition at line 693 of file BelosPCPGSolMgr.hpp.

template<class ScalarType , class MV , class OP >
Teuchos::RCP<const Teuchos::ParameterList> Belos::PCPGSolMgr< ScalarType, MV, OP, true >::getCurrentParameters ( ) const
inlinevirtual

Get a parameter list containing the current parameters for this object.

Implements Belos::SolverManager< ScalarType, MV, OP >.

Definition at line 264 of file BelosPCPGSolMgr.hpp.

template<class ScalarType , class MV , class OP >
Teuchos::Array<Teuchos::RCP<Teuchos::Time> > Belos::PCPGSolMgr< ScalarType, MV, OP, true >::getTimers ( ) const
inline

Return the timers for this object.

The timers are ordered as follows:

Definition at line 271 of file BelosPCPGSolMgr.hpp.

template<class ScalarType , class MV , class OP >
MagnitudeType Belos::PCPGSolMgr< ScalarType, MV, OP, true >::achievedTol ( ) const
inlinevirtual

Tolerance achieved by the last solve() invocation.

This is the maximum over all right-hand sides' achieved convergence tolerances, and is set whether or not the solve actually managed to achieve the desired convergence tolerance.

Reimplemented from Belos::SolverManager< ScalarType, MV, OP >.

Definition at line 280 of file BelosPCPGSolMgr.hpp.

template<class ScalarType , class MV , class OP >
int Belos::PCPGSolMgr< ScalarType, MV, OP, true >::getNumIters ( ) const
inlinevirtual

Get the iteration count for the most recent call to solve().

Implements Belos::SolverManager< ScalarType, MV, OP >.

Definition at line 285 of file BelosPCPGSolMgr.hpp.

template<class ScalarType , class MV , class OP >
bool Belos::PCPGSolMgr< ScalarType, MV, OP, true >::isLOADetected ( ) const
inlinevirtual

Return whether a loss of accuracy was detected by this solver during the most current solve.

Implements Belos::SolverManager< ScalarType, MV, OP >.

Definition at line 291 of file BelosPCPGSolMgr.hpp.

template<class ScalarType , class MV , class OP >
void Belos::PCPGSolMgr< ScalarType, MV, OP, true >::setProblem ( const Teuchos::RCP< LinearProblem< ScalarType, MV, OP > > &  problem)
inlinevirtual

Set the linear problem that needs to be solved.

Implements Belos::SolverManager< ScalarType, MV, OP >.

Definition at line 299 of file BelosPCPGSolMgr.hpp.

template<class ScalarType , class MV , class OP >
void Belos::PCPGSolMgr< ScalarType, MV, OP, true >::setParameters ( const Teuchos::RCP< Teuchos::ParameterList > &  params)
virtual

Set the parameters the solver manager should use to solve the linear problem.

Implements Belos::SolverManager< ScalarType, MV, OP >.

Definition at line 478 of file BelosPCPGSolMgr.hpp.

template<class ScalarType , class MV , class OP >
void Belos::PCPGSolMgr< ScalarType, MV, OP, true >::reset ( const ResetType  type)
inlinevirtual

Performs a reset of the solver manager specified by the ResetType. This informs the solver manager that the solver should prepare for the next call to solve by resetting certain elements of the iterative solver strategy.

Implements Belos::SolverManager< ScalarType, MV, OP >.

Definition at line 312 of file BelosPCPGSolMgr.hpp.

template<class ScalarType , class MV , class OP >
ReturnType Belos::PCPGSolMgr< ScalarType, MV, OP, true >::solve ( )
virtual

The method either solves the problem or decides to quit. On each call, a (possibly null) seed space is used to accelerate convergence.

The method calls PCPGIter::iterate(), which will return either because a specially constructed status test evaluates to Passed or an exception is thrown. The first Krylov vectors are appended to the seed space.

A return from PCPGIter::iterate() signifies one of the following scenarios:

  • the maximum number of restarts has been exceeded. In this scenario, the current solutions to the linear system will be placed in the linear problem and return Unconverged.
  • global convergence has been met. In this case, the current solutions to the linear system will be placed in the linear problem and the solver manager will return Converged
Returns
ReturnType specifying:
  • Converged: the linear problem was solved to the specification required by the solver manager.
  • Unconverged: the linear problem was not solved to the specification desired by the solver manager.

Implements Belos::SolverManager< ScalarType, MV, OP >.

Definition at line 736 of file BelosPCPGSolMgr.hpp.

template<class ScalarType , class MV , class OP >
std::string Belos::PCPGSolMgr< ScalarType, MV, OP, true >::description ( ) const
virtual

Method to return description of the PCPG solver manager.

Reimplemented from Teuchos::Describable.

Definition at line 1225 of file BelosPCPGSolMgr.hpp.

template<class ScalarType , class MV , class OP >
int Belos::PCPGSolMgr< ScalarType, MV, OP, true >::ARRQR ( int  numVecs,
int  numOrthVecs,
const Teuchos::SerialDenseMatrix< int, ScalarType > &  D 
)
private

Definition at line 1116 of file BelosPCPGSolMgr.hpp.

Member Data Documentation

template<class ScalarType , class MV , class OP >
Teuchos::RCP<LinearProblem<ScalarType,MV,OP> > Belos::PCPGSolMgr< ScalarType, MV, OP, true >::problem_
private

Definition at line 354 of file BelosPCPGSolMgr.hpp.

template<class ScalarType , class MV , class OP >
Teuchos::RCP<OutputManager<ScalarType> > Belos::PCPGSolMgr< ScalarType, MV, OP, true >::printer_
private

Definition at line 357 of file BelosPCPGSolMgr.hpp.

template<class ScalarType , class MV , class OP >
Teuchos::RCP<std::ostream> Belos::PCPGSolMgr< ScalarType, MV, OP, true >::outputStream_
private

Definition at line 358 of file BelosPCPGSolMgr.hpp.

template<class ScalarType , class MV , class OP >
Teuchos::RCP<StatusTest<ScalarType,MV,OP> > Belos::PCPGSolMgr< ScalarType, MV, OP, true >::sTest_
private

Definition at line 361 of file BelosPCPGSolMgr.hpp.

template<class ScalarType , class MV , class OP >
Teuchos::RCP<StatusTestMaxIters<ScalarType,MV,OP> > Belos::PCPGSolMgr< ScalarType, MV, OP, true >::maxIterTest_
private

Definition at line 362 of file BelosPCPGSolMgr.hpp.

template<class ScalarType , class MV , class OP >
Teuchos::RCP<StatusTestGenResNorm<ScalarType,MV,OP> > Belos::PCPGSolMgr< ScalarType, MV, OP, true >::convTest_
private

Definition at line 363 of file BelosPCPGSolMgr.hpp.

template<class ScalarType , class MV , class OP >
Teuchos::RCP<StatusTestOutput<ScalarType,MV,OP> > Belos::PCPGSolMgr< ScalarType, MV, OP, true >::outputTest_
private

Definition at line 364 of file BelosPCPGSolMgr.hpp.

template<class ScalarType , class MV , class OP >
Teuchos::RCP<MatOrthoManager<ScalarType,MV,OP> > Belos::PCPGSolMgr< ScalarType, MV, OP, true >::ortho_
private

Definition at line 367 of file BelosPCPGSolMgr.hpp.

template<class ScalarType , class MV , class OP >
Teuchos::RCP<Teuchos::ParameterList> Belos::PCPGSolMgr< ScalarType, MV, OP, true >::params_
private

Definition at line 370 of file BelosPCPGSolMgr.hpp.

template<class ScalarType , class MV , class OP >
constexpr int Belos::PCPGSolMgr< ScalarType, MV, OP, true >::maxIters_default_ = 1000
staticprivate

Definition at line 373 of file BelosPCPGSolMgr.hpp.

template<class ScalarType , class MV , class OP >
constexpr int Belos::PCPGSolMgr< ScalarType, MV, OP, true >::deflatedBlocks_default_ = 2
staticprivate

Definition at line 374 of file BelosPCPGSolMgr.hpp.

template<class ScalarType , class MV , class OP >
constexpr int Belos::PCPGSolMgr< ScalarType, MV, OP, true >::savedBlocks_default_ = 16
staticprivate

Definition at line 375 of file BelosPCPGSolMgr.hpp.

template<class ScalarType , class MV , class OP >
constexpr int Belos::PCPGSolMgr< ScalarType, MV, OP, true >::verbosity_default_ = Belos::Errors
staticprivate

Definition at line 376 of file BelosPCPGSolMgr.hpp.

template<class ScalarType , class MV , class OP >
constexpr int Belos::PCPGSolMgr< ScalarType, MV, OP, true >::outputStyle_default_ = Belos::General
staticprivate

Definition at line 377 of file BelosPCPGSolMgr.hpp.

template<class ScalarType , class MV , class OP >
constexpr int Belos::PCPGSolMgr< ScalarType, MV, OP, true >::outputFreq_default_ = -1
staticprivate

Definition at line 378 of file BelosPCPGSolMgr.hpp.

template<class ScalarType , class MV , class OP >
constexpr const char* Belos::PCPGSolMgr< ScalarType, MV, OP, true >::label_default_ = "Belos"
staticprivate

Definition at line 379 of file BelosPCPGSolMgr.hpp.

template<class ScalarType , class MV , class OP >
constexpr const char* Belos::PCPGSolMgr< ScalarType, MV, OP, true >::orthoType_default_ = "ICGS"
staticprivate

Definition at line 380 of file BelosPCPGSolMgr.hpp.

template<class ScalarType , class MV , class OP >
constexpr std::ostream* Belos::PCPGSolMgr< ScalarType, MV, OP, true >::outputStream_default_ = &std::cout
staticprivate

Definition at line 381 of file BelosPCPGSolMgr.hpp.

template<class ScalarType , class MV , class OP >
MagnitudeType Belos::PCPGSolMgr< ScalarType, MV, OP, true >::convtol_
private

Convergence tolerance (read from parameter list).

Definition at line 388 of file BelosPCPGSolMgr.hpp.

template<class ScalarType , class MV , class OP >
MagnitudeType Belos::PCPGSolMgr< ScalarType, MV, OP, true >::orthoKappa_
private

Orthogonalization parameter (read from parameter list).

Definition at line 391 of file BelosPCPGSolMgr.hpp.

template<class ScalarType , class MV , class OP >
MagnitudeType Belos::PCPGSolMgr< ScalarType, MV, OP, true >::achievedTol_
private

Tolerance achieved by the last solve() invocation.

Definition at line 394 of file BelosPCPGSolMgr.hpp.

template<class ScalarType , class MV , class OP >
int Belos::PCPGSolMgr< ScalarType, MV, OP, true >::numIters_
private

Number of iterations taken by the last solve() invocation.

Definition at line 397 of file BelosPCPGSolMgr.hpp.

template<class ScalarType , class MV , class OP >
int Belos::PCPGSolMgr< ScalarType, MV, OP, true >::maxIters_
private

Maximum iteration count (read from parameter list).

Definition at line 400 of file BelosPCPGSolMgr.hpp.

template<class ScalarType , class MV , class OP >
int Belos::PCPGSolMgr< ScalarType, MV, OP, true >::deflatedBlocks_
private

Definition at line 402 of file BelosPCPGSolMgr.hpp.

template<class ScalarType , class MV , class OP >
int Belos::PCPGSolMgr< ScalarType, MV, OP, true >::savedBlocks_
private

Definition at line 402 of file BelosPCPGSolMgr.hpp.

template<class ScalarType , class MV , class OP >
int Belos::PCPGSolMgr< ScalarType, MV, OP, true >::verbosity_
private

Definition at line 402 of file BelosPCPGSolMgr.hpp.

template<class ScalarType , class MV , class OP >
int Belos::PCPGSolMgr< ScalarType, MV, OP, true >::outputStyle_
private

Definition at line 402 of file BelosPCPGSolMgr.hpp.

template<class ScalarType , class MV , class OP >
int Belos::PCPGSolMgr< ScalarType, MV, OP, true >::outputFreq_
private

Definition at line 402 of file BelosPCPGSolMgr.hpp.

template<class ScalarType , class MV , class OP >
std::string Belos::PCPGSolMgr< ScalarType, MV, OP, true >::orthoType_
private

Definition at line 403 of file BelosPCPGSolMgr.hpp.

template<class ScalarType , class MV , class OP >
Teuchos::RCP<MV> Belos::PCPGSolMgr< ScalarType, MV, OP, true >::U_
private

Definition at line 406 of file BelosPCPGSolMgr.hpp.

template<class ScalarType , class MV , class OP >
Teuchos::RCP<MV> Belos::PCPGSolMgr< ScalarType, MV, OP, true >::C_
private

Definition at line 406 of file BelosPCPGSolMgr.hpp.

template<class ScalarType , class MV , class OP >
Teuchos::RCP<MV> Belos::PCPGSolMgr< ScalarType, MV, OP, true >::R_
private

Definition at line 406 of file BelosPCPGSolMgr.hpp.

template<class ScalarType , class MV , class OP >
int Belos::PCPGSolMgr< ScalarType, MV, OP, true >::dimU_
private

Definition at line 409 of file BelosPCPGSolMgr.hpp.

template<class ScalarType , class MV , class OP >
std::string Belos::PCPGSolMgr< ScalarType, MV, OP, true >::label_
private

Definition at line 412 of file BelosPCPGSolMgr.hpp.

template<class ScalarType , class MV , class OP >
Teuchos::RCP<Teuchos::Time> Belos::PCPGSolMgr< ScalarType, MV, OP, true >::timerSolve_
private

Definition at line 413 of file BelosPCPGSolMgr.hpp.

template<class ScalarType , class MV , class OP >
bool Belos::PCPGSolMgr< ScalarType, MV, OP, true >::isSet_
private

Definition at line 416 of file BelosPCPGSolMgr.hpp.


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