10 #include "Thyra_EpetraLinearOp.hpp"
12 #include "Thyra_SpmdMultiVectorBase.hpp"
13 #include "Thyra_MultiVectorStdOps.hpp"
14 #include "Thyra_AssertOp.hpp"
15 #include "Teuchos_dyn_cast.hpp"
16 #include "Teuchos_Assert.hpp"
17 #include "Teuchos_getConst.hpp"
18 #include "Teuchos_as.hpp"
19 #include "Teuchos_TimeMonitor.hpp"
21 #include "Epetra_Map.h"
22 #include "Epetra_Vector.h"
23 #include "Epetra_Operator.h"
24 #include "Epetra_CrsMatrix.h"
34 :isFullyInitialized_(false),
51 using Teuchos::rcp_dynamic_cast;
57 "Thyra::EpetraLinearOp::initialize(...): Error!" );
63 l_spmdRange = rcp_dynamic_cast<
const SPMDVSB>(range_in,
true);
70 l_spmdDomain = rcp_dynamic_cast<const SPMDVSB>(domain_in,
true);
76 isFullyInitialized_ =
true;
81 adjointSupport_ = adjointSupport;
83 domain_ = l_spmdDomain;
98 using Teuchos::rcp_dynamic_cast;
104 "Thyra::EpetraLinearOp::partiallyInitialize(...): Error!" );
106 "Thyra::EpetraLinearOp::partiallyInitialize(...): Error!" );
108 "Thyra::EpetraLinearOp::partiallyInitialize(...): Error!" );
112 l_spmdRange = rcp_dynamic_cast<
const SPMDVSB>(range_in,
true);
114 l_spmdDomain = rcp_dynamic_cast<
const SPMDVSB>(domain_in,
true);
117 isFullyInitialized_ =
false;
122 adjointSupport_ = adjointSupport;
123 range_ = l_spmdRange;
124 domain_ = l_spmdDomain;
132 isFullyInitialized_ =
true;
147 if(opTrans) *opTrans = opTrans_;
148 if(applyAs) *applyAs = applyAs_;
149 if(adjointSupport) *adjointSupport = adjointSupport_;
150 if(range_out) *range_out = range_;
151 if(domain_out) *domain_out = domain_;
153 isFullyInitialized_ =
false;
155 rowMatrix_ = Teuchos::null;
159 range_ = Teuchos::null;
160 domain_ = Teuchos::null;
204 *epetraOpTransp = opTrans_;
205 *epetraOpApplyAs = applyAs_;
206 *epetraOpAdjointSupport = adjointSupport_;
218 *epetraOpTransp = opTrans_;
219 *epetraOpApplyAs = applyAs_;
220 *epetraOpAdjointSupport = adjointSupport_;
245 return Teuchos::null;
254 std::ostringstream oss;
257 oss <<
"op=\'"<<
typeName(*op_)<<
"\'";
258 oss <<
",rangeDim="<<this->
range()->dim();
259 oss <<
",domainDim="<<this->
domain()->dim();
276 using Teuchos::rcp_dynamic_cast;
278 using Teuchos::describe;
287 <<
"rangeDim=" << this->
range()->dim()
288 <<
",domainDim=" << this->
domain()->dim()
293 out <<
"opTrans="<<
toString(opTrans_)<<
"\n";
294 out <<
"applyAs="<<
toString(applyAs_)<<
"\n";
295 out <<
"adjointSupport="<<
toString(adjointSupport_)<<
"\n";
308 out <<
"op=NULL"<<
"\n";
322 if (!isFullyInitialized_)
338 THYRA_FUNC_TIME_MONITOR(
"Thyra::EpetraLinearOp::euclideanApply");
345 "EpetraLinearOp::euclideanApply(...)", *
this, M_trans, X_in, Y_inout
350 "EpetraLinearOp::apply(...): *this was informed that adjoints "
351 "are not supported when initialized."
356 const int numCols = XY_domain->dim();
369 THYRA_FUNC_TIME_MONITOR_DIFF(
370 "Thyra::EpetraLinearOp::euclideanApply: Convert MultiVectors", MultiVectors);
373 real_M_trans==
NOTRANS ? getDomainMap() : getRangeMap(), X_in );
377 real_M_trans==
NOTRANS ? getRangeMap() : getDomainMap(), *Y_inout );
397 THYRA_FUNC_TIME_MONITOR_DIFF(
398 "Thyra::EpetraLinearOp::euclideanApply: Apply", Apply);
402 THYRA_FUNC_TIME_MONITOR_DIFF(
403 "Thyra::EpetraLinearOp::euclideanApply: Apply(beta==0): Apply",
405 op_->
Apply( *X, *Y );
408 THYRA_FUNC_TIME_MONITOR_DIFF(
409 "Thyra::EpetraLinearOp::euclideanApply: Apply(beta==0): ApplyInverse",
420 THYRA_FUNC_TIME_MONITOR_DIFF(
421 "Thyra::EpetraLinearOp::euclideanApply: Apply(beta==0): Scale Y",
429 THYRA_FUNC_TIME_MONITOR_DIFF(
430 "Thyra::EpetraLinearOp::euclideanApply: Apply(beta!=0): Scale Y",
432 scale( beta, Y_inout );
435 THYRA_FUNC_TIME_MONITOR_DIFF(
436 "Thyra::EpetraLinearOp::euclideanApply: Apply(beta!=0): Y=0",
438 assign( Y_inout, 0.0 );
446 THYRA_FUNC_TIME_MONITOR_DIFF(
447 "Thyra::EpetraLinearOp::euclideanApply: Apply(beta!=0): Apply",
452 THYRA_FUNC_TIME_MONITOR_DIFF(
453 "Thyra::EpetraLinearOp::euclideanApply: Apply(beta!=0): ApplyInverse",
464 THYRA_FUNC_TIME_MONITOR_DIFF(
465 "Thyra::EpetraLinearOp::euclideanApply: Apply(beta!=0): Update Y",
506 using Teuchos::rcpFromRef;
515 using Teuchos::rcpFromRef;
526 const RowStatLinearOpBaseUtils::ERowStat rowStat)
const
532 case RowStatLinearOpBaseUtils::ROW_STAT_INV_ROW_SUM:
533 case RowStatLinearOpBaseUtils::ROW_STAT_ROW_SUM:
543 const RowStatLinearOpBaseUtils::ERowStat rowStat,
547 using Teuchos::rcpFromPtr;
551 case RowStatLinearOpBaseUtils::ROW_STAT_INV_ROW_SUM:
554 case RowStatLinearOpBaseUtils::ROW_STAT_ROW_SUM:
556 computeAbsRowSum(*rowStatVec);
595 const Epetra_Map& EpetraLinearOp::getRangeMap()
const
603 const Epetra_Map& EpetraLinearOp::getDomainMap()
const
610 void EpetraLinearOp::computeAbsRowSum(
Epetra_Vector & x)
const
614 RCP<Epetra_CrsMatrix> crsMatrix
618 Exceptions::OpNotSupported,
619 "EpetraLinearOp::computeAbsRowSum(...): wrapped matrix must be of type "
620 "Epetra_CrsMatrix for this method. Other operator types are not supported."
628 if (crsMatrix->Filled()) {
630 std::invalid_argument,
631 "EpetraLinearOp::computeAbsRowSum(...): Epetra_CrsMatrix must be filled"
636 double * xp = (
double*)x.Values();
637 if (crsMatrix->Graph().RangeMap().SameAs(x.Map()) && crsMatrix->Exporter() != 0) {
639 x_tmp.PutScalar(0.0);
640 double * x_tmp_p = (
double*)x_tmp.Values();
641 for (i=0; i < crsMatrix->NumMyRows(); i++) {
643 double * RowValues = 0;
644 crsMatrix->ExtractMyRowView(i,NumEntries,RowValues);
645 for (j=0; j < NumEntries; j++) x_tmp_p[i] += std::abs(RowValues[j]);
649 else if (crsMatrix->Graph().RowMap().SameAs(x.Map())) {
650 for (i=0; i < crsMatrix->NumMyRows(); i++) {
652 double * RowValues = 0;
653 crsMatrix->ExtractMyRowView(i,NumEntries,RowValues);
655 for (j=0; j < NumEntries; j++) scale += std::abs(RowValues[j]);
671 Thyra::nonconstEpetraLinearOp()
678 Thyra::partialNonconstEpetraLinearOp(
679 const RCP<
const VectorSpaceBase<double> > &range,
680 const RCP<
const VectorSpaceBase<double> > &domain,
681 const RCP<Epetra_Operator> &op,
687 RCP<EpetraLinearOp> thyraEpetraOp =
Teuchos::rcp(
new EpetraLinearOp());
688 thyraEpetraOp->partiallyInitialize(
689 range, domain,op,opTrans, applyAs, adjointSupport
691 return thyraEpetraOp;
696 Thyra::nonconstEpetraLinearOp(
697 const RCP<Epetra_Operator> &op,
701 const RCP<
const VectorSpaceBase<double> > &range,
702 const RCP<
const VectorSpaceBase<double> > &domain
705 RCP<EpetraLinearOp> thyraEpetraOp =
Teuchos::rcp(
new EpetraLinearOp());
706 thyraEpetraOp->initialize(
707 op,opTrans, applyAs, adjointSupport, range, domain
709 return thyraEpetraOp;
714 Thyra::epetraLinearOp(
715 const RCP<const Epetra_Operator> &op,
719 const RCP<
const VectorSpaceBase<double> > &range,
720 const RCP<
const VectorSpaceBase<double> > &domain
723 RCP<EpetraLinearOp> thyraEpetraOp =
Teuchos::rcp(
new EpetraLinearOp());
724 thyraEpetraOp->initialize(
725 Teuchos::rcp_const_cast<Epetra_Operator>(op),
726 opTrans, applyAs, adjointSupport, range, domain
728 return thyraEpetraOp;
733 Thyra::nonconstEpetraLinearOp(
734 const RCP<Epetra_Operator> &op,
735 const std::string &label,
739 const RCP<
const VectorSpaceBase<double> > &range,
740 const RCP<
const VectorSpaceBase<double> > &domain
743 RCP<EpetraLinearOp> thyraEpetraOp =
Teuchos::rcp(
new EpetraLinearOp());
744 thyraEpetraOp->initialize(
745 op,opTrans, applyAs, adjointSupport, range, domain
747 thyraEpetraOp->setObjectLabel(label);
748 return thyraEpetraOp;
753 Thyra::epetraLinearOp(
754 const RCP<const Epetra_Operator> &op,
755 const std::string &label,
759 const RCP<
const SpmdVectorSpaceBase<double> > &range,
760 const RCP<
const SpmdVectorSpaceBase<double> > &domain
763 RCP<EpetraLinearOp> thyraEpetraOp =
Teuchos::rcp(
new EpetraLinearOp());
764 thyraEpetraOp->initialize(
765 Teuchos::rcp_const_cast<Epetra_Operator>(op),
766 opTrans, applyAs, adjointSupport, range, domain
768 thyraEpetraOp->setObjectLabel(label);
769 return thyraEpetraOp;
RCP< const SpmdVectorSpaceBase< double > > spmdDomain() const
Return a smart pointer to the SpmdVectorSpaceBase object for the domain.
RCP< Epetra_MultiVector > get_Epetra_MultiVector(const Epetra_Map &map, const RCP< MultiVectorBase< double > > &mv)
Get a non-const Epetra_MultiVector view from a non-const MultiVectorBase object if possible...
virtual RCP< const SpmdVectorSpaceBase< double > > allocateDomain(const RCP< Epetra_Operator > &op, EOpTransp op_trans) const
Allocate the domain space of the operator.
virtual bool supportsScaleRightImpl() const
virtual int RightScale(const Epetra_Vector &x)=0
bool is_null(const boost::shared_ptr< T > &p)
EOpTransp
Enumeration for determining how a linear operator is applied. `*.
virtual int SetUseTranspose(bool UseTranspose)=0
basic_OSTab< char > OSTab
void partiallyInitialize(const RCP< const VectorSpaceBase< double > > &range, const RCP< const VectorSpaceBase< double > > &domain, const RCP< Epetra_Operator > &op, EOpTransp opTrans=NOTRANS, EApplyEpetraOpAs applyAs=EPETRA_OP_APPLY_APPLY, EAdjointEpetraOp adjointSupport=EPETRA_OP_ADJOINT_SUPPORTED)
Partially initialize.
#define THYRA_ASSERT_LINEAR_OP_MULTIVEC_APPLY_SPACES(FUNC_NAME, M, M_T, X, Y)
This is a very useful macro that should be used to validate that the spaces for the multi-vector vers...
RCP< const SpmdVectorSpaceBase< double > > spmdRange() const
Return a smart pointer to the SpmdVectorSpaceBase object for the range.
virtual bool rowStatIsSupportedImpl(const RowStatLinearOpBaseUtils::ERowStat rowStat) const
RCP< const VectorSpaceBase< double > > create_VectorSpace(const RCP< const Epetra_Map > &epetra_map)
Create an VectorSpaceBase object given an Epetra_Map object.
virtual int ApplyInverse(const Epetra_MultiVector &X, Epetra_MultiVector &Y) const =0
virtual bool supportsScaleLeftImpl() const
basic_FancyOStream< char > FancyOStream
#define TEUCHOS_TEST_FOR_EXCEPTION(throw_exception_test, Exception, msg)
Use the non-transposed operator.
EOpTransp real_trans(EOpTransp transp)
Return NOTRANS or TRANS for real scalar valued operators and this also is used for determining struct...
virtual const Epetra_Map & OperatorDomainMap() const =0
virtual int LeftScale(const Epetra_Vector &x)=0
std::string description() const
Abstract interface for objects that represent a space for vectors.
virtual int InvRowSums(Epetra_Vector &x) const =0
void getEpetraOpView(const Ptr< RCP< const Epetra_Operator > > &epetraOp, const Ptr< EOpTransp > &epetraOpTransp, const Ptr< EApplyEpetraOpAs > &epetraOpApplyAs, const Ptr< EAdjointEpetraOp > &epetraOpAdjointSupport) const
RCP< MultiVectorBase< double > > create_MultiVector(const RCP< Epetra_MultiVector > &epetra_mv, const RCP< const VectorSpaceBase< double > > &range=Teuchos::null, const RCP< const VectorSpaceBase< double > > &domain=Teuchos::null)
Create a non-const MultiVectorBase object from a non-const Epetra_MultiVector object.
Use the transposed operator.
Apply using Epetra_Operator::ApplyInverse(...)
void initialize(const RCP< Epetra_Operator > &op, EOpTransp opTrans=NOTRANS, EApplyEpetraOpAs applyAs=EPETRA_OP_APPLY_APPLY, EAdjointEpetraOp adjointSupport=EPETRA_OP_ADJOINT_SUPPORTED, const RCP< const VectorSpaceBase< double > > &range=Teuchos::null, const RCP< const VectorSpaceBase< double > > &domain=Teuchos::null)
Fully initialize.
virtual int Apply(const Epetra_MultiVector &X, Epetra_MultiVector &Y) const =0
virtual const Epetra_Map & OperatorRangeMap() const =0
virtual void scaleLeftImpl(const VectorBase< double > &row_scaling)
TEUCHOS_DEPRECATED RCP< T > rcp(T *p, Dealloc_T dealloc, bool owns_mem)
Interface for a collection of column vectors called a multi-vector.
virtual bool UseTranspose() const =0
EAdjointEpetraOp
Determine if adjoints are supported on Epetra_Opeator or not.
EpetraLinearOp()
Construct to uninitialized.
void setFullyInitialized(bool isFullyInitialized=true)
Set to fully initialized.
EOpTransp trans_trans(EOpTransp trans1, EOpTransp trans2)
Combine two transpose arguments.
void getNonconstEpetraOpView(const Ptr< RCP< Epetra_Operator > > &epetraOp, const Ptr< EOpTransp > &epetraOpTransp, const Ptr< EApplyEpetraOpAs > &epetraOpApplyAs, const Ptr< EAdjointEpetraOp > &epetraOpAdjointSupport)
RCP< Epetra_Vector > get_Epetra_Vector(const Epetra_Map &map, const RCP< VectorBase< double > > &v)
Get a non-const Epetra_Vector view from a non-const VectorBase object if possible.
virtual std::string description() const
Abstract interface for finite-dimensional dense vectors.
RCP< const VectorSpaceBase< double > > range() const
TEUCHOSCORE_LIB_DLL_EXPORT std::string toString(const EVerbosityLevel verbLevel)
RCP< const VectorSpaceBase< double > > domain() const
void applyImpl(const EOpTransp M_trans, const MultiVectorBase< double > &X, const Ptr< MultiVectorBase< double > > &Y, const double alpha, const double beta) const
void describe(FancyOStream &out, const Teuchos::EVerbosityLevel verbLevel) const
TEUCHOSCORE_LIB_DLL_EXPORT bool includesVerbLevel(const EVerbosityLevel verbLevel, const EVerbosityLevel requestedVerbLevel, const bool isDefaultLevel=false)
virtual RCP< const VectorSpaceBase< Scalar > > domain() const =0
Return a smart pointer for the domain space for this operator.
bool nonnull(const boost::shared_ptr< T > &p)
#define TEUCHOS_UNREACHABLE_RETURN(dummyReturnVal)
TypeTo as(const TypeFrom &t)
EApplyEpetraOpAs
Determine how the apply an Epetra_Operator as a linear operator.
void uninitialize(RCP< Epetra_Operator > *op=NULL, EOpTransp *opTrans=NULL, EApplyEpetraOpAs *applyAs=NULL, EAdjointEpetraOp *adjointSupport=NULL, RCP< const VectorSpaceBase< double > > *range=NULL, RCP< const VectorSpaceBase< double > > *domain=NULL)
Set to uninitialized and optionally return the current state.
#define TEUCHOS_ASSERT(assertion_test)
virtual void getRowStatImpl(const RowStatLinearOpBaseUtils::ERowStat rowStat, const Ptr< VectorBase< double > > &rowStatVec) const
virtual RCP< const SpmdVectorSpaceBase< double > > allocateRange(const RCP< Epetra_Operator > &op, EOpTransp op_trans) const
Allocate the range space of the operator.
bool opSupportedImpl(EOpTransp M_trans) const
Apply using Epetra_Operator::Apply(...)
Base abstract VectorSpaceBase class for all SPMD-based vector spaces.
virtual void scaleRightImpl(const VectorBase< double > &col_scaling)
#define TEUCHOS_TEST_FOR_EXCEPT(throw_exception_test)
virtual void Print(std::ostream &os) const
RCP< const LinearOpBase< double > > clone() const
std::string typeName(const T &t)
RCP< Epetra_Operator > epetra_op()