42 #ifndef BELOS_GMRESPOLYOP_HPP
43 #define BELOS_GMRESPOLYOP_HPP
82 #ifdef BELOS_TEUCHOS_TIME_MONITOR
84 #endif // BELOS_TEUCHOS_TIME_MONITOR
99 template <
class ScalarType,
class MV>
109 mv_ = Teuchos::rcp_const_cast<MV>( mv_in );
197 template <
class ScalarType,
class MV,
class OP>
208 : problem_(problem_in),
210 LP_(problem_in->getLeftPrec()),
211 RP_(problem_in->getRightPrec())
215 polyUpdateLabel_ = label_ +
": Hybrid Gmres: Vector Update";
216 #ifdef BELOS_TEUCHOS_TIME_MONITOR
218 #endif // BELOS_TEUCHOS_TIME_MONITOR
220 if (polyType_ ==
"Arnoldi" || polyType_==
"Roots")
222 else if (polyType_ ==
"Gmres")
226 "Belos::GmresPolyOp: \"Polynomial Type\" must be either \"Arnoldi\", \"Gmres\", or \"Roots\".");
231 : problem_(problem_in)
271 void ApplyPoly (
const MV& x, MV& y )
const;
290 #ifdef BELOS_TEUCHOS_TIME_MONITOR
292 #endif // BELOS_TEUCHOS_TIME_MONITOR
293 std::string polyUpdateLabel_;
302 static constexpr
int maxDegree_default_ = 25;
304 static constexpr
bool randomRHS_default_ =
true;
305 static constexpr
const char * label_default_ =
"Belos";
306 static constexpr
const char * polyType_default_ =
"Roots";
307 static constexpr
const char * orthoType_default_ =
"DGKS";
308 static constexpr std::ostream * outputStream_default_ = &std::cout;
309 static constexpr
bool damp_default_ =
false;
310 static constexpr
bool addRoots_default_ =
true;
326 int maxDegree_ = maxDegree_default_;
327 int verbosity_ = verbosity_default_;
328 bool randomRHS_ = randomRHS_default_;
329 std::string label_ = label_default_;
330 std::string polyType_ = polyType_default_;
331 std::string orthoType_ = orthoType_default_;
333 bool damp_ = damp_default_;
334 bool addRoots_ = addRoots_default_;
342 bool autoDeg =
false;
353 void ComputeAddedRoots();
356 template <
class ScalarType,
class MV,
class OP>
361 polyType_ = params_in->
get(
"Polynomial Type", polyType_default_);
365 if (params_in->
isParameter(
"Polynomial Tolerance")) {
366 if (params_in->
isType<MagnitudeType> (
"Polynomial Tolerance")) {
367 polyTol_ = params_in->
get (
"Polynomial Tolerance",
377 maxDegree_ = params_in->
get(
"Maximum Degree", maxDegree_default_);
382 randomRHS_ = params_in->
get(
"Random RHS", randomRHS_default_);
387 if (Teuchos::isParameterType<int>(*params_in,
"Verbosity")) {
388 verbosity_ = params_in->
get(
"Verbosity", verbosity_default_);
391 verbosity_ = (int)Teuchos::getParameter<Belos::MsgType>(*params_in,
"Verbosity");
396 orthoType_ = params_in->
get(
"Orthogonalization",orthoType_default_);
398 std::invalid_argument,
399 "Belos::GmresPolyOp: \"Orthogonalization\" must be either \"DGKS\", \"ICGS\", or \"IMGS\".");
404 label_ = params_in->
get(
"Timer Label", label_default_);
409 outputStream_ = Teuchos::getParameter<Teuchos::RCP<std::ostream> >(*params_in,
"Output Stream");
414 damp_ = params_in->
get(
"Damped Poly", damp_default_);
419 addRoots_ = params_in->
get(
"Add Roots", addRoots_default_);
423 template <
class ScalarType,
class MV,
class OP>
429 std::vector<int> index(1,0);
432 MVT::MvRandom( *V0 );
434 MVT::Assign( *problem_->getRHS(), *V0 );
436 if ( !LP_.is_null() ) {
438 problem_->applyLeftPrec( *Vtemp, *V0);
442 problem_->apply( *Vtemp, *V0);
445 for(
int i=0; i< maxDegree_+1; i++)
451 problem_->apply( *Vi, *Vip1);
460 MVT::MvTransMv( SCT::one(), *AV, *AV, AVtransAV);
469 while( status && dim_ >= 1)
479 std::cout <<
"BelosGmresPolyOp.hpp: LAPACK POTRF was not successful!!" << std::endl;
480 std::cout <<
"Error code: " << infoInt << std::endl;
501 pCoeff_.
shape( 1, 1);
502 pCoeff_(0,0) = SCT::one();
503 std::cout <<
"Poly Degree is zero. No preconditioner created." << std::endl;
507 pCoeff_.shape( dim_+1, 1);
513 MVT::MvTransMv( SCT::one(), *AVsub, *V0, pCoeff_);
514 lapack.
POTRS(
'U', dim_+1, 1, lhs.
values(), lhs.
stride(), pCoeff_.values(), pCoeff_.stride(), &infoInt);
517 std::cout <<
"BelosGmresPolyOp.hpp: LAPACK POTRS was not successful!!" << std::endl;
518 std::cout <<
"Error code: " << infoInt << std::endl;
523 template <
class ScalarType,
class MV,
class OP>
526 std::string polyLabel = label_ +
": GmresPolyOp creation";
529 std::vector<int> idx(1,0);
532 MVT::MvInit( *newX, SCT::zero() );
534 MVT::MvRandom( *newB );
537 MVT::Assign( *(MVT::CloneView(*(problem_->getRHS()), idx)), *newB );
541 newProblem->setInitResVec( newB );
542 newProblem->setLeftPrec( problem_->getLeftPrec() );
543 newProblem->setRightPrec( problem_->getRightPrec() );
544 newProblem->setLabel(polyLabel);
545 newProblem->setProblem();
546 newProblem->setLSIndex( idx );
552 polyList.
set(
"Num Blocks",maxDegree_);
553 polyList.
set(
"Block Size",1);
554 polyList.
set(
"Keep Hessenberg",
true);
557 if (ortho_.is_null()) {
558 params_->
set(
"Orthogonalization", orthoType_);
559 if (orthoType_==
"DGKS") {
562 else if (orthoType_==
"ICGS") {
565 else if (orthoType_==
"IMGS") {
570 "Belos::GmresPolyOp(): Invalid orthogonalization type.");
596 if ( !LP_.is_null() )
597 newProblem->applyLeftPrec( *newB, *V_0 );
601 newProblem->apply( *Vtemp, *V_0 );
608 int rank = ortho_->normalize( *V_0, Teuchos::rcpFromRef(r0_) );
610 "Belos::GmresPolyOp::generateArnoldiPoly(): Failed to compute initial block of orthonormal vectors for polynomial generation.");
615 newstate.
z = Teuchos::rcpFromRef( r0_);
617 gmres_iter->initializeGmres(newstate);
621 gmres_iter->iterate();
625 gmres_iter->updateLSQR( gmres_iter->getCurSubspaceDim() );
627 catch (std::exception e) {
629 printer_->stream(
Errors) <<
"Error! Caught exception in BlockGmresIter::iterate() at iteration "
630 << gmres_iter->getNumIters() << endl << e.what () << endl;
645 if(polyType_ ==
"Arnoldi"){
658 y_.values(), y_.stride() );
666 for(
int i=0; i <= dim_-3; i++) {
667 for(
int k=i+2; k <= dim_-1; k++) {
668 H_(k,i) = SCT::zero();
675 ScalarType Hlast = (*gmresState.
H)(dim_,dim_-1);
681 E(dim_-1,0) = SCT::one();
684 HSolver.
setMatrix( Teuchos::rcpFromRef(Htemp));
686 HSolver.
setVectors( Teuchos::rcpFromRef(F), Teuchos::rcpFromRef(E));
693 std::cout <<
"Hsolver factor: info = " << info << std::endl;
695 info = HSolver.
solve();
697 std::cout <<
"Hsolver solve : info = " << info << std::endl;
701 F.scale(Hlast*Hlast);
706 theta_.shape(dim_,2);
713 std::vector<ScalarType> work(1);
714 std::vector<MagnitudeType> rwork(2*dim_);
717 lapack.
GEEV(
'N',
'N',dim_,H_.values(),H_.stride(),theta_[0],theta_[1],vlr, ldv, vlr, ldv, &work[0], lwork, &rwork[0], &info);
719 work.resize( lwork );
721 lapack.
GEEV(
'N',
'N',dim_,H_.values(),H_.stride(),theta_[0],theta_[1],vlr, ldv, vlr, ldv, &work[0], lwork, &rwork[0], &info);
724 std::cout <<
"GEEV solve : info = " << info << std::endl;
728 std::vector<int> index(dim_);
729 for(
int i=0; i<dim_; ++i){
732 SortModLeja(theta_,index);
741 template <
class ScalarType,
class MV,
class OP>
746 std::vector<std::complex<MagnitudeType>> cmplxHRitz (dim_);
747 for(
unsigned int i=0; i<cmplxHRitz.size(); ++i){
748 cmplxHRitz[i] = std::complex<MagnitudeType>( theta_(i,0), theta_(i,1) );
752 const MagnitudeType one(1.0);
753 std::vector<MagnitudeType> pof (dim_,one);
754 for(
int j=0; j<dim_; ++j) {
755 for(
int i=0; i<dim_; ++i) {
757 pof[j] = std::abs(pof[j]*(one-(cmplxHRitz[j]/cmplxHRitz[i])));
763 std::vector<int> extra (dim_);
765 for(
int i=0; i<dim_; ++i){
766 extra[i] = ceil((log10(pof[i])-MagnitudeType(4.0))/MagnitudeType(14.0));
768 totalExtra += extra[i];
772 printer_->stream(
Warnings) <<
"Warning: Need to add " << totalExtra <<
" extra roots." << std::endl;}
775 if(addRoots_ && totalExtra>0)
777 theta_.reshape(dim_+totalExtra,2);
783 for(
int i=0; i<dim_; ++i){
784 for(
int j=0; j< extra[i]; ++j){
785 theta_(count,0) = theta_(i,0);
786 theta_(count,1) = theta_(i,1);
787 thetaPert(count,0) = theta_(i,0)+(j+MCT::one())*MagnitudeType(5e-8);
788 thetaPert(count,1) = theta_(i,1);
796 printer_->stream(
Warnings) <<
"New poly degree is: " << dim_ << std::endl;}
799 std::vector<int> index2(dim_);
800 for(
int i=0; i<dim_; ++i){
803 SortModLeja(thetaPert,index2);
805 for(
int i=0; i<dim_; ++i)
807 thetaPert(i,0) = theta_(index2[i],0);
808 thetaPert(i,1) = theta_(index2[i],1);
817 template <
class ScalarType,
class MV,
class OP>
823 int dimN = index.size();
824 std::vector<int> newIndex(dimN);
830 for(
int i = 0; i < dimN; i++){
831 absVal(i) = hypot(thetaN(i,0), thetaN(i,1));
833 MagnitudeType * maxPointer = std::max_element(absVal.values(), (absVal.values()+dimN));
834 int maxIndex = int (maxPointer- absVal.values());
837 sorted(0,0) = thetaN(maxIndex,0);
838 sorted(0,1) = thetaN(maxIndex,1);
839 newIndex[0] = index[maxIndex];
843 if(sorted(0,1)!= SCT::zero() && !SCT::isComplex)
845 sorted(1,0) = thetaN(maxIndex,0);
846 sorted(1,1) = -thetaN(maxIndex,1);
847 newIndex[1] = index[maxIndex+1];
860 for(
int i = 0; i < dimN; i++)
862 prod(i) = MCT::one();
863 for(
int k = 0; k < j; k++)
865 a = thetaN(i,0) - sorted(k,0);
866 b = thetaN(i,1) - sorted(k,1);
867 prod(i) = prod(i) + log10(sqrt(a*a + b*b));
872 MagnitudeType * maxPointer = std::max_element(prod.values(), (prod.values()+dimN));
873 int maxIndex = int (maxPointer- prod.values());
874 sorted(j,0) = thetaN(maxIndex,0);
875 sorted(j,1) = thetaN(maxIndex,1);
876 newIndex[j] = index[maxIndex];
879 if(sorted(j,1)!= SCT::zero() && !SCT::isComplex)
882 sorted(j,0) = thetaN(maxIndex,0);
883 sorted(j,1) = -thetaN(maxIndex,1);
884 newIndex[j] = index[maxIndex+1];
894 template <
class ScalarType,
class MV,
class OP>
898 if (polyType_ ==
"Arnoldi")
899 ApplyArnoldiPoly(x, y);
900 else if (polyType_ ==
"Gmres")
901 ApplyGmresPoly(x, y);
902 else if (polyType_ ==
"Roots")
903 ApplyRootsPoly(x, y);
907 problem_->applyOp( x, y );
911 template <
class ScalarType,
class MV,
class OP>
918 if (!LP_.is_null()) {
920 problem_->applyLeftPrec( *AX, *Xtmp );
925 #ifdef BELOS_TEUCHOS_TIME_MONITOR
928 MVT::MvAddMv(pCoeff_(0,0), *AX, SCT::zero(), y, y);
930 for(
int i=1; i < dim_+1; i++)
943 problem_->apply(*X, *Y);
945 #ifdef BELOS_TEUCHOS_TIME_MONITOR
948 MVT::MvAddMv(pCoeff_(i,0), *Y, SCT::one(), y, y);
953 if (!RP_.is_null()) {
955 problem_->applyRightPrec( *Ytmp, y );
959 template <
class ScalarType,
class MV,
class OP>
962 MVT::MvInit( y, SCT::zero() );
968 if (!LP_.is_null()) {
969 problem_->applyLeftPrec( *prod, *Xtmp );
976 if(theta_(i,1)== SCT::zero() || SCT::isComplex)
979 #ifdef BELOS_TEUCHOS_TIME_MONITOR
982 MVT::MvAddMv(SCT::one(), y, SCT::one()/theta_(i,0), *prod, y);
984 problem_->apply(*prod, *Xtmp);
986 #ifdef BELOS_TEUCHOS_TIME_MONITOR
989 MVT::MvAddMv(SCT::one(), *prod, -SCT::one()/theta_(i,0), *Xtmp, *prod);
995 MagnitudeType mod = theta_(i,0)*theta_(i,0) + theta_(i,1)*theta_(i,1);
996 problem_->apply(*prod, *Xtmp);
998 #ifdef BELOS_TEUCHOS_TIME_MONITOR
1001 MVT::MvAddMv(2*theta_(i,0), *prod, -SCT::one(), *Xtmp, *Xtmp);
1002 MVT::MvAddMv(SCT::one(), y, SCT::one()/mod, *Xtmp, y);
1006 problem_->apply(*Xtmp, *Xtmp2);
1008 #ifdef BELOS_TEUCHOS_TIME_MONITOR
1011 MVT::MvAddMv(SCT::one(), *prod, -SCT::one()/mod, *Xtmp2, *prod);
1017 if(theta_(dim_-1,1)== SCT::zero() || SCT::isComplex)
1019 #ifdef BELOS_TEUCHOS_TIME_MONITOR
1022 MVT::MvAddMv(SCT::one(), y, SCT::one()/theta_(dim_-1,0), *prod, y);
1026 if (!RP_.is_null()) {
1028 problem_->applyRightPrec( *Ytmp, y );
1032 template <
class ScalarType,
class MV,
class OP>
1037 V_ = MVT::Clone( x, dim_ );
1038 if (!LP_.is_null()) {
1039 wL_ = MVT::Clone( y, 1 );
1041 if (!RP_.is_null()) {
1042 wR_ = MVT::Clone( y, 1 );
1048 int n = MVT::GetNumberVecs( x );
1049 std::vector<int> idxi(1), idxi2, idxj(1);
1052 for (
int j=0; j<n; ++j) {
1058 if (!LP_.is_null()) {
1060 problem_->applyLeftPrec( *x_view, *v_curr );
1062 MVT::SetBlock( *x_view, idxi, *V_ );
1065 for (
int i=0; i<dim_-1; ++i) {
1069 for (
int ii=0; ii<i+1; ++ii) { idxi2[ii] = ii; }
1081 if (!RP_.is_null()) {
1082 problem_->applyRightPrec( *v_curr, *wR_ );
1087 if (LP_.is_null()) {
1091 problem_->applyOp( *wR_, *wL_ );
1093 if (!LP_.is_null()) {
1094 problem_->applyLeftPrec( *wL_, *v_next );
1100 #ifdef BELOS_TEUCHOS_TIME_MONITOR
1103 MVT::MvTimesMatAddMv( -SCT::one(), *v_prev, h, SCT::one(), *v_next );
1107 MVT::MvScale( *v_next, SCT::one()/H_(i+1,i) );
1111 if (!RP_.is_null()) {
1113 #ifdef BELOS_TEUCHOS_TIME_MONITOR
1116 MVT::MvTimesMatAddMv( SCT::one()/r0_(0), *V_, y_, SCT::zero(), *wR_ );
1118 problem_->applyRightPrec( *wR_, *y_view );
1121 #ifdef BELOS_TEUCHOS_TIME_MONITOR
1124 MVT::MvTimesMatAddMv( SCT::one()/r0_(0), *V_, y_, SCT::zero(), *y_view );
ScaleType convertStringToScaleType(const std::string &scaleType)
Convert the given string to its ScaleType enum value.
ScalarType * values() const
GmresPolyMv(const Teuchos::RCP< const MV > &mv_in)
Collection of types and exceptions used within the Belos solvers.
const GmresPolyMv * CloneView(const std::vector< int > &index) const
Creates a new Belos::MultiVec that shares the selected contents of *this. The index of the numvecs ve...
void TRSM(ESide side, EUplo uplo, ETransp transa, EDiag diag, const OrdinalType &m, const OrdinalType &n, const alpha_type alpha, const A_type *A, const OrdinalType &lda, ScalarType *B, const OrdinalType &ldb) const
Belos's basic output manager for sending information of select verbosity levels to the appropriate ou...
void MvScale(const std::vector< ScalarType > &alpha)
Scale each element of the i-th vector in *this with alpha[i].
Class which manages the output and verbosity of the Belos solvers.
static void MvDot(const MV &mv, const MV &A, std::vector< ScalarType > &b)
Compute a vector b where the components are the individual dot-products of the i-th columns of A and ...
void MvAddMv(const ScalarType alpha, const MultiVec< ScalarType > &A, const ScalarType beta, const MultiVec< ScalarType > &B)
Replace *this with alpha * A + beta * B.
GmresPolyMv * CloneCopy() const
Create a new MultiVec and copy contents of *this into it (deep copy).
void MvScale(const ScalarType alpha)
Scale each element of the vectors in *this with alpha.
ptrdiff_t GetGlobalLength() const
The number of rows in the multivector.
static void MvRandom(MV &mv)
Replace the vectors in mv with random vectors.
This class implements the block GMRES iteration, where a block Krylov subspace is constructed...
Teuchos::RCP< const MV > V
The current Krylov basis.
Teuchos::RCP< MV > getMV()
T & get(const std::string &name, T def_value)
ParameterList & set(std::string const &name, T const &value, std::string const &docString="", RCP< const ParameterEntryValidator > const &validator=null)
void ApplyGmresPoly(const MV &x, MV &y) const
#define TEUCHOS_TEST_FOR_EXCEPTION(throw_exception_test, Exception, msg)
static Teuchos::RCP< const MV > CloneView(const MV &mv, const std::vector< int > &index)
Creates a new const MV that shares the selected contents of mv (shallow copy).
void generateGmresPoly()
This routine takes the matrix, preconditioner, and vectors from the linear problem as well as the par...
Declaration of basic traits for the multivector type.
void POTRS(const char &UPLO, const OrdinalType &n, const OrdinalType &nrhs, const ScalarType *A, const OrdinalType &lda, ScalarType *B, const OrdinalType &ldb, OrdinalType *info) const
Teuchos::RCP< const Teuchos::SerialDenseMatrix< int, ScalarType > > z
The current right-hand side of the least squares system RY = Z.
An implementation of StatusTestResNorm using a family of residual norms.
GmresPolyMv * CloneViewNonConst(const std::vector< int > &index)
Creates a new Belos::MultiVec that shares the selected contents of *this. The index of the numvecs ve...
GmresPolyMv * CloneCopy(const std::vector< int > &index) const
Creates a new Belos::MultiVec and copies the selected contents of *this into the new multivector (dee...
void MvRandom()
Fill all the vectors in *this with random numbers.
Structure to contain pointers to GmresIteration state variables.
GmresPolyOp(const Teuchos::RCP< LinearProblem< ScalarType, MV, OP > > &problem_in, const Teuchos::RCP< Teuchos::ParameterList > ¶ms_in)
Basic contstructor.
Belos::StatusTest class for specifying a maximum number of iterations.
static void MvInit(MV &mv, const ScalarType alpha=Teuchos::ScalarTraits< ScalarType >::zero())
Replace each element of the vectors in mv with alpha.
static const double polyTol
Relative residual tolerance for matrix polynomial construction.
static void MvTransMv(const ScalarType alpha, const MV &A, const MV &mv, Teuchos::SerialDenseMatrix< int, ScalarType > &B)
Compute a dense matrix B through the matrix-matrix multiply .
Class which defines basic traits for the operator type.
int GetNumberVecs() const
The number of vectors (i.e., columns) in the multivector.
static int GetNumberVecs(const MV &mv)
Obtain the number of vectors in mv.
A factory class for generating StatusTestOutput objects.
Iterated Modified Gram-Schmidt (IMGS) implementation of the Belos::OrthoManager class.
static void MvAddMv(const ScalarType alpha, const MV &A, const ScalarType beta, const MV &B, MV &mv)
Replace mv with .
ETrans
Whether to apply the (conjugate) transpose of an operator.
Traits class which defines basic operations on multivectors.
Belos::StatusTest for logically combining several status tests.
bool isParameter(const std::string &name) const
static void SetBlock(const MV &A, const std::vector< int > &index, MV &mv)
Copy the vectors in A to a set of vectors in mv indicated by the indices given in index...
Classical Gram-Schmidt (with DGKS correction) implementation of the Belos::OrthoManager class...
A Belos::StatusTest class for specifying a maximum number of iterations.
static Teuchos::RCP< MV > CloneViewNonConst(MV &mv, const std::vector< int > &index)
Creates a new MV that shares the selected contents of mv (shallow copy).
void MvTimesMatAddMv(const ScalarType alpha, const MultiVec< ScalarType > &A, const Teuchos::SerialDenseMatrix< int, ScalarType > &B, const ScalarType beta)
Update *this with alpha * A * B + beta * (*this).
static Teuchos::RCP< MV > Clone(const MV &mv, const int numvecs)
Creates a new empty MV containing numvecs columns.
Alternative run-time polymorphic interface for operators.
TEUCHOS_DEPRECATED RCP< T > rcp(T *p, Dealloc_T dealloc, bool owns_mem)
int curDim
The current dimension of the reduction.
void ApplyPoly(const MV &x, MV &y) const
This routine takes the MV x and applies the polynomial operator phi(OP) to it resulting in the MV y...
void POTRF(const char &UPLO, const OrdinalType &n, ScalarType *A, const OrdinalType &lda, OrdinalType *info) const
Teuchos::RCP< const Teuchos::SerialDenseMatrix< int, ScalarType > > R
The current upper-triangular matrix from the QR reduction of H.
int putScalar(const ScalarType value=Teuchos::ScalarTraits< ScalarType >::zero())
void factorWithEquilibration(bool flag)
void ApplyArnoldiPoly(const MV &x, MV &y) const
void MvNorm(std::vector< typename Teuchos::ScalarTraits< ScalarType >::magnitudeType > &normvec, NormType type=TwoNorm) const
Compute the norm of each vector in *this.
void solveWithTransposeFlag(Teuchos::ETransp trans)
A linear system to solve, and its associated information.
Class which describes the linear problem to be solved by the iterative solver.
GmresPolyOpOrthoFailure(const std::string &what_arg)
void SetBlock(const MultiVec< ScalarType > &A, const std::vector< int > &index)
Copy the vectors in A to a set of vectors in *this.
void ApplyRootsPoly(const MV &x, MV &y) const
static Teuchos::RCP< MV > CloneCopy(const MV &mv)
Creates a new MV and copies contents of mv into the new vector (deep copy).
Teuchos::RCP< const MV > getConstMV() const
static void MvTimesMatAddMv(const ScalarType alpha, const MV &A, const Teuchos::SerialDenseMatrix< int, ScalarType > &B, const ScalarType beta, MV &mv)
Update mv with .
Belos's class for applying the GMRES polynomial operator that is used by the hybrid-GMRES linear solv...
Belos concrete class for performing the block GMRES iteration.
Iterated Classical Gram-Schmidt (ICGS) implementation of the Belos::OrthoManager class.
An implementation of the Belos::MatOrthoManager that performs orthogonalization using multiple steps ...
An implementation of the Belos::MatOrthoManager that performs orthogonalization using multiple steps ...
OrdinalType numCols() const
static ptrdiff_t GetGlobalLength(const MV &mv)
Return the number of rows in the given multivector mv.
NormType
The type of vector norm to compute.
void MvInit(const ScalarType alpha)
Replace each element of the vectors in *this with alpha.
void MvDot(const MultiVec< ScalarType > &A, std::vector< ScalarType > &b) const
Compute the dot product of each column of *this with the corresponding column of A.
void MvTransMv(const ScalarType alpha, const MultiVec< ScalarType > &A, Teuchos::SerialDenseMatrix< int, ScalarType > &B) const
Compute a dense matrix B through the matrix-matrix multiply alpha * A^T * (*this).
int setVectors(const RCP< SerialDenseMatrix< OrdinalType, ScalarType > > &X, const RCP< SerialDenseMatrix< OrdinalType, ScalarType > > &B)
Alternative run-time polymorphic interface for operators.
virtual ~GmresPolyOp()
Destructor.
void GEEV(const char &JOBVL, const char &JOBVR, const OrdinalType &n, ScalarType *A, const OrdinalType &lda, MagnitudeType *WR, MagnitudeType *WI, ScalarType *VL, const OrdinalType &ldvl, ScalarType *VR, const OrdinalType &ldvr, ScalarType *WORK, const OrdinalType &lwork, MagnitudeType *RWORK, OrdinalType *info) const
GmresPolyMv * Clone(const int numvecs) const
Create a new MultiVec with numvecs columns.
Belos::StatusTestResNorm for specifying general residual norm stopping criteria.
Belos::StatusTest for specifying an implicit residual norm stopping criteria that checks for loss of ...
bool isType(const std::string &name) const
An implementation of the Belos::MatOrthoManager that performs orthogonalization using (potentially) m...
A class for extending the status testing capabilities of Belos via logical combinations.
Interface for multivectors used by Belos' linear solvers.
GmresPolyOp(const Teuchos::RCP< LinearProblem< ScalarType, MV, OP > > &problem_in)
Given no ParameterList, constructor creates no polynomial and only applies the given operator...
static void MvNorm(const MV &mv, std::vector< typename Teuchos::ScalarTraits< ScalarType >::magnitudeType > &normvec, NormType type=TwoNorm)
Compute the norm of each individual vector of mv. Upon return, normvec[i] holds the value of ...
void generateArnoldiPoly()
This routine takes the matrix, preconditioner, and vectors from the linear problem as well as the par...
static void MvScale(MV &mv, const ScalarType alpha)
Scale each element of the vectors in mv with alpha.
Parent class to all Belos exceptions.
int shape(OrdinalType numRows, OrdinalType numCols)
Pure virtual base class which augments the basic interface for a Gmres linear solver iteration...
GmresIterationOrthoFailure is thrown when the GmresIteration object is unable to compute independent ...
Belos header file which uses auto-configuration information to include necessary C++ headers...
static void MvPrint(const MV &mv, std::ostream &os)
Print the mv multi-vector to the os output stream.
GmresPolyOpOrthoFailure is thrown when the orthogonalization manager is unable to generate orthonorma...
void MvPrint(std::ostream &os) const
Print *this multivector to the os output stream.
OrdinalType stride() const
void Apply(const MultiVec< ScalarType > &x, MultiVec< ScalarType > &y, ETrans=NOTRANS) const
This routine casts the MultiVec to GmresPolyMv to retrieve the MV. Then the above apply method is cal...
void setParameters(const Teuchos::RCP< Teuchos::ParameterList > ¶ms_in)
Process the passed in parameters.
OrdinalType numRows() const
int setMatrix(const RCP< SerialDenseMatrix< OrdinalType, ScalarType > > &A)
Interface for multivectors used by Belos' linear solvers.
GmresPolyMv(const Teuchos::RCP< MV > &mv_in)
Teuchos::RCP< const Teuchos::SerialDenseMatrix< int, ScalarType > > H
The current Hessenberg matrix.