42 #ifndef BELOS_CG_ITER_HPP
43 #define BELOS_CG_ITER_HPP
77 template<
class ScalarType,
class MV,
class OP>
200 "Belos::CGIter::setBlockSize(): Cannot use a block size that is not one.");
209 if (numEntriesForCondEst_) doCondEst_=val;
218 if (static_cast<size_type> (iter_) >= diag_.
size ()) {
221 return diag_ (0, iter_);
233 if (static_cast<size_type> (iter_) >= offdiag_.
size ()) {
236 return offdiag_ (0, iter_);
268 bool stateStorageInitialized_;
274 bool assertPositiveDefiniteness_;
278 int numEntriesForCondEst_;
302 template<
class ScalarType,
class MV,
class OP>
311 stateStorageInitialized_(false),
313 assertPositiveDefiniteness_( params.get(
"Assert Positive Definiteness", true) ),
314 numEntriesForCondEst_(params.get(
"Max Size For Condest",0) ),
321 template <
class ScalarType,
class MV,
class OP>
324 if (!stateStorageInitialized_) {
329 if (lhsMV == Teuchos::null && rhsMV == Teuchos::null) {
330 stateStorageInitialized_ =
false;
337 if (R_ == Teuchos::null) {
341 "Belos::CGIter::setStateSize(): linear problem does not specify multivectors to clone from.");
342 R_ = MVT::Clone( *tmp, 1 );
343 Z_ = MVT::Clone( *tmp, 1 );
344 P_ = MVT::Clone( *tmp, 1 );
345 AP_ = MVT::Clone( *tmp, 1 );
349 if(numEntriesForCondEst_ > 0) {
350 diag_.resize(numEntriesForCondEst_);
351 offdiag_.resize(numEntriesForCondEst_-1);
355 stateStorageInitialized_ =
true;
363 template <
class ScalarType,
class MV,
class OP>
367 if (!stateStorageInitialized_)
371 "Belos::CGIter::initialize(): Cannot initialize state storage!");
375 std::string errstr(
"Belos::CGIter::initialize(): Specified multivectors must have a consistent length and width.");
381 if (newstate.
R != Teuchos::null) {
384 std::invalid_argument, errstr );
386 std::invalid_argument, errstr );
389 if (newstate.
R != R_) {
391 MVT::MvAddMv( one, *newstate.
R, zero, *newstate.
R, *R_ );
397 if ( lp_->getLeftPrec() != Teuchos::null ) {
398 lp_->applyLeftPrec( *R_, *Z_ );
399 if ( lp_->getRightPrec() != Teuchos::null ) {
401 lp_->applyRightPrec( *Z_, *tmp );
405 else if ( lp_->getRightPrec() != Teuchos::null ) {
406 lp_->applyRightPrec( *R_, *Z_ );
411 MVT::MvAddMv( one, *Z_, zero, *Z_, *P_ );
416 "Belos::CGIter::initialize(): CGIterationState does not have initial residual.");
426 template <
class ScalarType,
class MV,
class OP>
432 if (initialized_ ==
false) {
437 std::vector<ScalarType> alpha(1);
438 std::vector<ScalarType> beta(1);
439 std::vector<ScalarType> rHz(1), rHz_old(1), pAp(1);
446 ScalarType pAp_old = one, beta_old = one, rHz_old2 = one;
453 "Belos::CGIter::iterate(): current linear system has more than one vector!" );
456 MVT::MvDot( *R_, *Z_, rHz );
461 while (stest_->checkStatus(
this) !=
Passed) {
467 lp_->applyOp( *P_, *AP_ );
470 MVT::MvDot( *P_, *AP_, pAp );
471 alpha[0] = rHz[0] / pAp[0];
474 if(assertPositiveDefiniteness_)
476 "Belos::CGIter::iterate(): non-positive value for p^H*A*p encountered!" );
480 MVT::MvAddMv( one, *cur_soln_vec, alpha[0], *P_, *cur_soln_vec );
481 lp_->updateSolution();
489 MVT::MvAddMv( one, *R_, -alpha[0], *AP_, *R_ );
494 if ( lp_->getLeftPrec() != Teuchos::null ) {
495 lp_->applyLeftPrec( *R_, *Z_ );
496 if ( lp_->getRightPrec() != Teuchos::null ) {
498 lp_->applyRightPrec( *Z_, *tmp );
502 else if ( lp_->getRightPrec() != Teuchos::null ) {
503 lp_->applyRightPrec( *R_, *Z_ );
509 MVT::MvDot( *R_, *Z_, rHz );
511 beta[0] = rHz[0] / rHz_old[0];
513 MVT::MvAddMv( one, *Z_, beta[0], *P_, *P_ );
524 rHz_old2 = rHz_old[0];
Teuchos::RCP< const MV > R
The current residual.
Collection of types and exceptions used within the Belos solvers.
Teuchos::ScalarTraits< ScalarType > SCT
Belos's basic output manager for sending information of select verbosity levels to the appropriate ou...
Class which manages the output and verbosity of the Belos solvers.
void setDoCondEst(bool val)
Sets whether or not to store the diagonal for condition estimation.
This class implements the preconditioned Conjugate Gradient (CG) iteration.
Structure to contain pointers to CGIteration state variables.
Pure virtual base class which augments the basic interface for a conjugate gradient linear solver ite...
Pure virtual base class for defining the status testing capabilities of Belos.
#define TEUCHOS_TEST_FOR_EXCEPTION(throw_exception_test, Exception, msg)
static magnitudeType real(T a)
Declaration of basic traits for the multivector type.
void setBlockSize(int blockSize)
Set the blocksize to be used by the iterative solver in solving this linear problem.
MultiVecTraits< ScalarType, MV > MVT
A pure virtual class for defining the status tests for the Belos iterative solvers.
Class which defines basic traits for the operator type.
CGIter(const Teuchos::RCP< LinearProblem< ScalarType, MV, OP > > &problem, const Teuchos::RCP< OutputManager< ScalarType > > &printer, const Teuchos::RCP< StatusTest< ScalarType, MV, OP > > &tester, Teuchos::ParameterList ¶ms)
CGIter constructor with linear problem, solver utilities, and parameter list of solver options...
CGIterateFailure is thrown when the CGIteration object is unable to compute the next iterate in the C...
Teuchos::RCP< const MV > AP
The matrix A applied to current decent direction vector.
CGIterationState< ScalarType, MV > getState() const
Get the current state of the linear solver.
bool isInitialized()
States whether the solver has been initialized or not.
OperatorTraits< ScalarType, MV, OP > OPT
int getNumIters() const
Get the current iteration count.
Traits class which defines basic operations on multivectors.
Teuchos::ArrayView< MagnitudeType > getDiag()
Gets the diagonal for condition estimation.
int getBlockSize() const
Get the blocksize to be used by the iterative solver in solving this linear problem.
void iterate()
This method performs CG iterations until the status test indicates the need to stop or an error occur...
A linear system to solve, and its associated information.
Class which describes the linear problem to be solved by the iterative solver.
Teuchos::ArrayView< MagnitudeType > getOffDiag()
Gets the off-diagonal for condition estimation.
Teuchos::RCP< const MV > Z
The current preconditioned residual.
virtual ~CGIter()
Destructor.
void initialize()
Initialize the solver with the initial vectors from the linear problem or random data.
Teuchos::RCP< MV > getCurrentUpdate() const
Get the current update to the linear system.
SCT::magnitudeType MagnitudeType
void resetNumIters(int iter=0)
Reset the iteration count.
const LinearProblem< ScalarType, MV, OP > & getProblem() const
Get a constant reference to the linear problem.
Class which defines basic traits for the operator type.
Teuchos::RCP< const MV > getNativeResiduals(std::vector< MagnitudeType > *) const
Get the norms of the residuals native to the solver.
Belos header file which uses auto-configuration information to include necessary C++ headers...
Teuchos::RCP< const MV > P
The current decent direction vector.
void initializeCG(CGIterationState< ScalarType, MV > &newstate)
Initialize the solver to an iterate, providing a complete state.