46 #ifndef ANASAZI_EPETRA_ADAPTER_HPP 47 #define ANASAZI_EPETRA_ADAPTER_HPP 50 #include "Anasaziepetra_DLLExportMacro.h" 56 #include "Teuchos_Assert.hpp" 58 #include "Teuchos_FancyOStream.hpp" 60 #include "Epetra_MultiVector.h" 61 #include "Epetra_Vector.h" 62 #include "Epetra_Operator.h" 63 #include "Epetra_Map.h" 64 #include "Epetra_LocalMap.h" 65 #include "Epetra_Comm.h" 67 #if defined(HAVE_ANASAZI_TPETRA) && defined(HAVE_ANASAZI_TSQR) 68 # include <Tpetra_ConfigDefs.hpp> 69 # if defined(HAVE_TPETRA_EPETRA) 70 # include <Epetra_TsqrAdaptor.hpp> 71 # endif // defined(HAVE_TPETRA_EPETRA) 72 #endif // defined(HAVE_ANASAZI_TPETRA) && defined(HAVE_ANASAZI_TSQR) 217 if ( Map().GlobalIndicesLongLong() )
218 return static_cast<ptrdiff_t
>( GlobalLength64() );
220 return static_cast<ptrdiff_t
>( GlobalLength() );
245 #ifdef HAVE_ANASAZI_EXPERIMENTAL
253 #ifdef HAVE_ANASAZI_EXPERIMENTAL
262 "Anasazi::EpetraMultiVec::MvScale call to Epetra_MultiVector::Scale() returned a nonzero value.");
267 void MvScale (
const std::vector<double>& alpha );
276 void MvNorm ( std::vector<double> & normvec )
const {
277 if (((
int)normvec.size() >= GetNumberVecs()) ) {
279 "Anasazi::EpetraMultiVec::MvNorm call to Epetra_MultiVector::Norm2() returned a nonzero value.");
297 "Anasazi::EpetraMultiVec::MvRandom call to Epetra_MultiVector::Random() returned a nonzero value.");
304 "Anasazi::EpetraMultiVec::MvInit call to Epetra_MultiVector::PutScalar() returned a nonzero value.");
323 void MvPrint( std::ostream& os )
const { os << *
this << std::endl; };
367 #pragma warning(push) 368 #pragma warning(disable:4251) 404 bool isAInverse =
true );
425 const char*
Label()
const {
return "Epetra_Operator applying A^{-1}M"; };
454 #pragma warning(push) 455 #pragma warning(disable:4251) 509 const char*
Label()
const {
return "Epetra_Operator applying A^TA or AA^T"; };
536 #pragma warning(push) 537 #pragma warning(disable:4251) 572 bool isTrans =
false );
587 #pragma warning(push) 588 #pragma warning(disable:4251) 636 #pragma warning(push) 637 #pragma warning(disable:4251) 685 #pragma warning(push) 686 #pragma warning(disable:4251) 731 "Belos::MultiVecTraits<double, Epetra_MultiVector>::" 732 "Clone(mv, outNumVecs = " << outNumVecs <<
"): " 733 "outNumVecs must be positive.");
760 const int outNumVecs = index.size();
764 "Anasazi::MultiVecTraits<double,Epetra_MultiVector>::" 765 "CloneCopy(mv, index = {}): At least one vector must be" 767 if (outNumVecs > inNumVecs)
769 std::ostringstream os;
770 os <<
"Anasazi::MultiVecTraits<double,Epetra_MultiVector>::" 771 "CloneCopy(mv, index = {";
772 for (
int k = 0; k < outNumVecs - 1; ++k)
773 os << index[k] <<
", ";
774 os << index[outNumVecs-1] <<
"}): There are " << outNumVecs
775 <<
" indices to copy, but only " << inNumVecs <<
" columns of mv.";
783 const int minIndex = *std::min_element (index.begin(), index.end());
784 const int maxIndex = *std::max_element (index.begin(), index.end());
788 std::ostringstream os;
789 os <<
"Anasazi::MultiVecTraits<double,Epetra_MultiVector>::" 790 "CloneCopy(mv, index = {";
791 for (
int k = 0; k < outNumVecs - 1; ++k)
792 os << index[k] <<
", ";
793 os << index[outNumVecs-1] <<
"}): Indices must be nonnegative, but " 794 "the smallest index " << minIndex <<
" is negative.";
797 if (maxIndex >= inNumVecs)
799 std::ostringstream os;
800 os <<
"Anasazi::MultiVecTraits<double,Epetra_MultiVector>::" 801 "CloneCopy(mv, index = {";
802 for (
int k = 0; k < outNumVecs - 1; ++k)
803 os << index[k] <<
", ";
804 os << index[outNumVecs-1] <<
"}): Indices must be strictly less than " 805 "the number of vectors " << inNumVecs <<
" in mv; the largest index " 806 << maxIndex <<
" is out of bounds.";
809 #endif // TEUCHOS_DEBUG 813 std::vector<int>& tmpind =
const_cast< std::vector<int>&
> (index);
821 const int outNumVecs = index.
size();
822 const bool validRange = outNumVecs > 0 && index.
lbound() >= 0 &&
823 index.
ubound() < inNumVecs;
826 std::ostringstream os;
827 os <<
"Anasazi::MultiVecTraits<double,Epetra_MultiVector>::Clone(mv," 828 "index=[" << index.
lbound() <<
", " << index.
ubound() <<
"]): ";
830 os.str() <<
"Column index range must be nonempty.");
832 os.str() <<
"Column index range must be nonnegative.");
834 os.str() <<
"Column index range must not exceed " 835 "number of vectors " << inNumVecs <<
" in the " 836 "input multivector.");
850 const int outNumVecs = index.size();
854 "Anasazi::MultiVecTraits<double,Epetra_MultiVector>::" 855 "CloneViewNonConst(mv, index = {}): The output view " 856 "must have at least one column.");
857 if (outNumVecs > inNumVecs)
859 std::ostringstream os;
860 os <<
"Anasazi::MultiVecTraits<double,Epetra_MultiVector>::" 861 "CloneViewNonConst(mv, index = {";
862 for (
int k = 0; k < outNumVecs - 1; ++k)
863 os << index[k] <<
", ";
864 os << index[outNumVecs-1] <<
"}): There are " << outNumVecs
865 <<
" indices to view, but only " << inNumVecs <<
" columns of mv.";
873 const int minIndex = *std::min_element (index.begin(), index.end());
874 const int maxIndex = *std::max_element (index.begin(), index.end());
878 std::ostringstream os;
879 os <<
"Anasazi::MultiVecTraits<double,Epetra_MultiVector>::" 880 "CloneViewNonConst(mv, index = {";
881 for (
int k = 0; k < outNumVecs - 1; ++k)
882 os << index[k] <<
", ";
883 os << index[outNumVecs-1] <<
"}): Indices must be nonnegative, but " 884 "the smallest index " << minIndex <<
" is negative.";
887 if (maxIndex >= inNumVecs)
889 std::ostringstream os;
890 os <<
"Anasazi::MultiVecTraits<double,Epetra_MultiVector>::" 891 "CloneViewNonConst(mv, index = {";
892 for (
int k = 0; k < outNumVecs - 1; ++k)
893 os << index[k] <<
", ";
894 os << index[outNumVecs-1] <<
"}): Indices must be strictly less than " 895 "the number of vectors " << inNumVecs <<
" in mv; the largest index " 896 << maxIndex <<
" is out of bounds.";
899 #endif // TEUCHOS_DEBUG 903 std::vector<int>& tmpind =
const_cast< std::vector<int>&
> (index);
910 const bool validRange = index.
size() > 0 &&
915 std::ostringstream os;
916 os <<
"Anasazi::MultiVecTraits<double,Epetra_MultiVector>::CloneView" 917 "NonConst(mv,index=[" << index.
lbound() <<
", " << index.
ubound()
920 os.str() <<
"Column index range must be nonempty.");
922 os.str() <<
"Column index range must be nonnegative.");
924 std::invalid_argument,
925 os.str() <<
"Column index range must not exceed " 926 "number of vectors " << mv.
NumVectors() <<
" in " 927 "the input multivector.");
941 const int outNumVecs = index.size();
945 "Belos::MultiVecTraits<double,Epetra_MultiVector>::" 946 "CloneView(mv, index = {}): The output view " 947 "must have at least one column.");
948 if (outNumVecs > inNumVecs)
950 std::ostringstream os;
951 os <<
"Belos::MultiVecTraits<double,Epetra_MultiVector>::" 952 "CloneView(mv, index = {";
953 for (
int k = 0; k < outNumVecs - 1; ++k)
954 os << index[k] <<
", ";
955 os << index[outNumVecs-1] <<
"}): There are " << outNumVecs
956 <<
" indices to view, but only " << inNumVecs <<
" columns of mv.";
964 const int minIndex = *std::min_element (index.begin(), index.end());
965 const int maxIndex = *std::max_element (index.begin(), index.end());
969 std::ostringstream os;
970 os <<
"Belos::MultiVecTraits<double,Epetra_MultiVector>::" 971 "CloneView(mv, index = {";
972 for (
int k = 0; k < outNumVecs - 1; ++k)
973 os << index[k] <<
", ";
974 os << index[outNumVecs-1] <<
"}): Indices must be nonnegative, but " 975 "the smallest index " << minIndex <<
" is negative.";
978 if (maxIndex >= inNumVecs)
980 std::ostringstream os;
981 os <<
"Belos::MultiVecTraits<double,Epetra_MultiVector>::" 982 "CloneView(mv, index = {";
983 for (
int k = 0; k < outNumVecs - 1; ++k)
984 os << index[k] <<
", ";
985 os << index[outNumVecs-1] <<
"}): Indices must be strictly less than " 986 "the number of vectors " << inNumVecs <<
" in mv; the largest index " 987 << maxIndex <<
" is out of bounds.";
990 #endif // TEUCHOS_DEBUG 994 std::vector<int>& tmpind =
const_cast< std::vector<int>&
> (index);
1001 const bool validRange = index.
size() > 0 &&
1006 std::ostringstream os;
1007 os <<
"Anasazi::MultiVecTraits<double,Epetra_MultiVector>::CloneView" 1008 "(mv,index=[" << index.
lbound() <<
", " << index.
ubound()
1011 os.str() <<
"Column index range must be nonempty.");
1013 os.str() <<
"Column index range must be nonnegative.");
1015 std::invalid_argument,
1016 os.str() <<
"Column index range must not exceed " 1017 "number of vectors " << mv.
NumVectors() <<
" in " 1018 "the input multivector.");
1032 return static_cast<ptrdiff_t>( mv.GlobalLength64() );
1058 "Anasazi::MultiVecTraits<double, Epetra_MultiVector>::MvTimesMatAddMv call to Epetra_MultiVector::Multiply() returned a nonzero value.");
1097 "Anasazi::MultiVecTraits<double, Epetra_MultiVector>::MvAddMv call to Epetra_MultiVector::Update(alpha,A,0.0) returned a nonzero value.");
1100 else if (alpha == 0.0) {
1108 "Anasazi::MultiVecTraits<double, Epetra_MultiVector>::MvAddMv call to Epetra_MultiVector::Update(beta,B,0.0) returned a nonzero value.");
1114 "Anasazi::MultiVecTraits<double, Epetra_MultiVector>::MvAddMv call to Epetra_MultiVector::Update(alpha,A,beta,B,0.0) returned a nonzero value.");
1121 #ifdef HAVE_ANASAZI_EXPERIMENTAL
1127 Epetra_MultiVector B_Pvec(Epetra_DataAccess::View, LocalMap, B.values(), B.stride(), B.numCols());
1130 "Anasazi::MultiVecTraits<double, Epetra_MultiVector>::MvTransMv call to Epetra_MultiVector::Multiply() returned a nonzero value.");
1136 #ifdef HAVE_ANASAZI_EXPERIMENTAL
1141 #ifdef TEUCHOS_DEBUG 1143 "Anasazi::MultiVecTraits<double,Epetra_MultiVector>::MvDot(A,B,b): A and B must have the same number of vectors.");
1145 "Anasazi::MultiVecTraits<double,Epetra_MultiVector>::MvDot(A,B,b): b must have room for all dot products.");
1148 "Anasazi::MultiVecTraits<double, Epetra_MultiVector>::MvDot(A,B,b) call to Epetra_MultiVector::Dot() returned a nonzero value.");
1160 #ifdef TEUCHOS_DEBUG 1162 "Anasazi::MultiVecTraits<double,Epetra_MultiVector>::MvNorm(mv,normvec): normvec must be the same size of mv.");
1165 "Anasazi::MultiVecTraits<double, Epetra_MultiVector>::MvNorm call to Epetra_MultiVector::Norm2() returned a nonzero value.");
1176 const std::vector<int>& index,
1180 const int outNumVecs = index.size();
1188 if (inNumVecs != outNumVecs)
1190 std::ostringstream os;
1191 os <<
"Belos::MultiVecTraits<double,Epetra_MultiVector>::" 1192 "SetBlock(A, mv, index = {";
1195 for (
int k = 0; k < outNumVecs - 1; ++k)
1196 os << index[k] <<
", ";
1197 os << index[outNumVecs-1];
1199 os <<
"}): A has only " << inNumVecs <<
" columns, but there are " 1200 << outNumVecs <<
" indices in the index vector.";
1210 if (outNumVecs == inNumVecs)
1211 A_view = Teuchos::rcpFromRef (A);
1233 const bool validIndex = index.
lbound() >= 0 && index.
ubound() < numColsMv;
1235 const bool validSource = index.
size() <= numColsA;
1237 if (! validIndex || ! validSource)
1239 std::ostringstream os;
1240 os <<
"Anasazi::MultiVecTraits<double, Epetra_MultiVector>::SetBlock" 1241 "(A, index=[" << index.
lbound() <<
", " << index.
ubound() <<
"], " 1244 os.str() <<
"Range lower bound must be nonnegative.");
1246 os.str() <<
"Range upper bound must be less than " 1247 "the number of columns " << numColsA <<
" in the " 1248 "'mv' output argument.");
1250 os.str() <<
"Range must have no more elements than" 1251 " the number of columns " << numColsA <<
" in the " 1252 "'A' input argument.");
1261 if (index.
lbound() == 0 && index.
ubound()+1 == numColsMv)
1262 mv_view = Teuchos::rcpFromRef (mv);
1270 if (index.
size() == numColsA)
1271 A_view = Teuchos::rcpFromRef (A);
1291 if (numColsA > numColsMv)
1293 std::ostringstream os;
1294 os <<
"Anasazi::MultiVecTraits<double, Epetra_MultiVector>::Assign" 1297 os.str() <<
"Input multivector 'A' has " 1298 << numColsA <<
" columns, but output multivector " 1299 "'mv' has only " << numColsMv <<
" columns.");
1304 if (numColsMv == numColsA)
1305 mv_view = Teuchos::rcpFromRef (mv);
1324 "Anasazi::MultiVecTraits<double, Epetra_MultiVector>::MvScale call to Epetra_MultiVector::Scale(mv,double alpha) returned a nonzero value.");
1333 #ifdef TEUCHOS_DEBUG 1335 "Anasazi::MultiVecTraits<double, Epetra_MultiVector>::MvScale(mv,vector alpha): size of alpha inconsistent with number of vectors in mv.")
1337 for (
int i=0; i<numvecs; i++) {
1339 "Anasazi::MultiVecTraits<double, Epetra_MultiVector>::MvScale call to Epetra_MultiVector::Scale() returned a nonzero value.");
1348 "Anasazi::MultiVecTraits<double, Epetra_MultiVector>::MvRandom call to Epetra_MultiVector::Random() returned a nonzero value.");
1356 "Anasazi::MultiVecTraits<double, Epetra_MultiVector>::MvInit call to Epetra_MultiVector::PutScalar() returned a nonzero value.");
1367 { os << mv << std::endl; }
1371 #if defined(HAVE_ANASAZI_TPETRA) && defined(HAVE_ANASAZI_TSQR) 1372 # if defined(HAVE_TPETRA_EPETRA) 1373 typedef Epetra::TsqrAdaptor tsqr_adaptor_type;
1379 # endif // defined(HAVE_TPETRA_EPETRA) 1380 #endif // defined(HAVE_ANASAZI_TPETRA) && defined(HAVE_ANASAZI_TSQR) 1412 #ifdef TEUCHOS_DEBUG 1414 "Anasazi::OperatorTraits<double,Epetra_MultiVector,Epetra_Operator>::Apply(Op,x,y): x and y must have the same number of columns.");
1416 int ret = Op.
Apply(x,y);
1418 "Anasazi::OperatorTraits<double,Epetra_Multivector,Epetra_Operator>::Apply(): Error in Epetra_Operator::Apply(). Code " << ret);
1433 int myRank = comm.
MyPID();
1434 int numProcs = comm.
NumProc();
1437 comm.
MinAll( &myRank, &rootRank, 1 );
int Norm2(double *Result) const
basic_FancyOStream & setProcRankAndSize(const int procRank, const int numProcs)
void MvRandom()
Fill the vectors in *this with random numbers.
const Epetra_BlockMap & Map() const
int Dot(const Epetra_MultiVector &A, double *Result) const
Adapter class for creating an operators often used in solving generalized eigenproblems.
EpetraMultiVecAccessor is an interfaceto allow any Anasazi::MultiVec implementation that is based on ...
const Epetra_Comm & Comm() const
Returns the Epetra_Comm communicator associated with this operator.
ScalarType * values() const
bool ConstantStride() const
static void MvAddMv(double alpha, const Epetra_MultiVector &A, double beta, const Epetra_MultiVector &B, Epetra_MultiVector &mv)
Replace mv with .
void MvInit(double alpha)
Replace each element of the vectors in *this with alpha.
static void SetBlock(const Epetra_MultiVector &A, const std::vector< int > &index, Epetra_MultiVector &mv)
Copy the vectors in A to a set of vectors in mv indicated by the indices given in index...
virtual ~EpetraMultiVecAccessor()
Destructor.
~EpetraSymMVOp()
Destructor.
Adapter class for creating a weighted symmetric operator from an Epetra_MultiVector and Epetra_Operat...
ptrdiff_t GetGlobalLength() const
The number of rows in the multivector.
static void MvInit(Epetra_MultiVector &mv, double alpha=Teuchos::ScalarTraits< double >::zero())
Replace each element of the vectors in mv with alpha.
int PutScalar(double ScalarConstant)
#define TEUCHOS_TEST_FOR_EXCEPTION(throw_exception_test, Exception, msg)
~EpetraWSymMVOp()
Destructor.
Virtual base class which defines basic traits for the operator type.
const char * Label() const
Returns a character string describing the operator.
virtual Epetra_MultiVector * GetEpetraMultiVec()
Return the pointer to the Epetra_MultiVector object.
static void MvPrint(const Epetra_MultiVector &mv, std::ostream &os)
Print the mv multi-vector to the os output stream.
static void MvRandom(Epetra_MultiVector &mv)
Replace the vectors in mv with random vectors.
static void MvTransMv(double alpha, const Epetra_MultiVector &A, const Epetra_MultiVector &mv, Teuchos::SerialDenseMatrix< int, double > &B)
Compute a dense matrix B through the matrix-matrix multiply .
static void Assign(const MV &A, MV &mv)
mv := A
bool UseTranspose() const
Returns the current UseTranspose setting [always false for this operator].
virtual int MinAll(double *PartialMins, double *GlobalMins, int Count) const=0
An exception class parent to all Anasazi exceptions.
double NormInf() const
Returns the infinity norm of the global matrix [not functional for this operator].
virtual int MyPID() const=0
Interface for multivectors used by Anasazi' linear solvers.
Namespace Anasazi contains the classes, structs, enums and utilities used by the Anasazi package...
Basic adapter class for Anasazi::Operator that uses Epetra_Operator.
static void MvDot(const Epetra_MultiVector &A, const Epetra_MultiVector &B, std::vector< double > &b)
Compute a vector b where the components are the individual dot-products of the i-th columns of A and ...
bool HasNormInf() const
Returns true if this object can provide an approximate inf-norm [always false for this operator]...
const Epetra_Map & OperatorRangeMap() const
Returns the Epetra_Map object associated with the range of this operator.
virtual int Apply(const Epetra_MultiVector &X, Epetra_MultiVector &Y) const=0
double NormInf() const
Returns the infinity norm of the global matrix [not functional for this operator].
int Scale(double ScalarValue)
virtual const Epetra_Comm & Comm() const=0
const Epetra_Comm & Comm() const
Returns the Epetra_Comm communicator associated with this operator.
ConjType
Enumerated types used to specify conjugation arguments.
TEUCHOS_DEPRECATED RCP< T > rcp(T *p, Dealloc_T dealloc, bool owns_mem)
OrdinalType numRows() const
bool UseTranspose() const
Returns the current UseTranspose setting [always false for this operator].
static Teuchos::RCP< Epetra_MultiVector > CloneCopy(const Epetra_MultiVector &mv, const std::vector< int > &index)
Creates a new Epetra_MultiVector and copies the selected contents of mv into the new vector (deep cop...
Epetra_MultiVector * GetEpetraMultiVec()
Return the pointer to the Epetra_MultiVector object.
int GetNumberVecs() const
The number of vectors (i.e., columns) in the multivector.
const char * Label() const
Returns a character string describing the operator.
const Epetra_Map & OperatorRangeMap() const
Returns the Epetra_Map object associated with the range of this operator.
static void MvScale(Epetra_MultiVector &mv, const std::vector< double > &alpha)
Scale each element of the i-th vector in mv with alpha[i].
static void MvTimesMatAddMv(double alpha, const Epetra_MultiVector &A, const Teuchos::SerialDenseMatrix< int, double > &B, double beta, Epetra_MultiVector &mv)
Update mv with .
Traits class which defines basic operations on multivectors.
static Teuchos::RCP< MV > CloneCopy(const MV &mv)
Creates a new MV and copies contents of mv into the new vector (deep copy).
static Teuchos::RCP< const Epetra_MultiVector > CloneView(const Epetra_MultiVector &mv, const std::vector< int > &index)
Creates a new const Epetra_MultiVector that shares the selected contents of mv (shallow copy)...
Adapter class for creating a weighted operator from an Epetra_MultiVector and Epetra_Operator.
virtual const Epetra_MultiVector * GetEpetraMultiVec() const
Return the pointer to the Epetra_MultiVector object.
const Epetra_Map & OperatorDomainMap() const
Returns the Epetra_Map object associated with the domain of this operator.
const Epetra_Comm & Comm() const
static Teuchos::RCP< Epetra_MultiVector > Clone(const Epetra_MultiVector &mv, const int outNumVecs)
Creates a new empty Epetra_MultiVector containing numVecs columns.
Anasazi header file which uses auto-configuration information to include necessary C++ headers...
basic_FancyOStream & setOutputToRootOnly(const int rootRank)
void MvPrint(std::ostream &os) const
Print *this EpetraMultiVec.
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).
static ptrdiff_t GetGlobalLength(const Epetra_MultiVector &mv)
Obtain the vector length of mv.
int SetUseTranspose(bool)
If set true, the transpose of this operator will be applied [not functional for this operator]...
Adapter class for creating a symmetric operator from an Epetra_Operator.
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).
const Epetra_MultiVector * GetEpetraMultiVec() const
Return the pointer to the Epetra_MultiVector object.
void MvScale(double alpha)
Scale each element of the vectors in *this with alpha.
static void MvScale(Epetra_MultiVector &mv, double alpha)
Scale each element of the vectors in mv with alpha.
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...
static void Apply(const Epetra_Operator &Op, const Epetra_MultiVector &x, Epetra_MultiVector &y)
This method takes the Epetra_MultiVector x and applies the Epetra_Operator Op to it resulting in the ...
~EpetraW2SymMVOp()
Destructor.
static int GetNumberVecs(const MV &mv)
Obtain the number of vectors in mv.
int Update(double ScalarA, const Epetra_MultiVector &A, double ScalarThis)
Templated virtual class for creating operators that can interface with the Anasazi::OperatorTraits cl...
int Multiply(char TransA, char TransB, double ScalarAB, const Epetra_MultiVector &A, const Epetra_MultiVector &B, double ScalarThis)
virtual int NumProc() const=0
static Teuchos::RCP< Epetra_MultiVector > CloneViewNonConst(Epetra_MultiVector &mv, const std::vector< int > &index)
Creates a new Epetra_MultiVector that shares the selected contents of mv (shallow copy)...
void MvNorm(std::vector< double > &normvec) const
Compute the 2-norm of each individual vector of *this. Upon return, normvec[i] holds the 2-norm of t...
EpetraMultiVecFailure is thrown when a return value from an Epetra call on an Epetra_MultiVector is n...
Types and exceptions used within Anasazi solvers and interfaces.
Abstract class definition for Anasazi output stream.
OrdinalType stride() const
OrdinalType numCols() const
bool GlobalIndicesLongLong() const
Interface for multivectors used by Anasazi's linear solvers.
Adapter class for creating a symmetric operator from an Epetra_MultiVector.
static void MvNorm(const Epetra_MultiVector &mv, std::vector< double > &normvec)
Compute the 2-norm of each individual vector of mv. Upon return, normvec[i] holds the value of ...
static int GetNumberVecs(const Epetra_MultiVector &mv)
Obtain the number of vectors in mv.
static Teuchos::RCP< Epetra_MultiVector > CloneCopy(const Epetra_MultiVector &mv)
Creates a new Epetra_MultiVector and copies contents of mv into the new vector (deep copy)...
Anasazi's templated virtual class for constructing an operator that can interface with the OperatorTr...
virtual ~EpetraMultiVec()
Destructor.
int SetUseTranspose(bool)
If set true, the transpose of this operator will be applied [not functional for this operator]...
EpetraOpFailure is thrown when a return value from an Epetra call on an Epetra_Operator is non-zero...
Exceptions thrown to signal error in operator application.
const Epetra_Map & OperatorDomainMap() const
Returns the Epetra_Map object associated with the domain of this operator.
Basic adapter class for Anasazi::MultiVec that uses Epetra_MultiVector.
bool HasNormInf() const
Returns true if this object can provide an approximate inf-norm [always false for this operator]...