10 #include "Thyra_EpetraOperatorWrapper.hpp"
12 #include "Thyra_DetachedSpmdVectorView.hpp"
13 #include "Thyra_DefaultProductVector.hpp"
14 #include "Thyra_ProductVectorSpaceBase.hpp"
15 #include "Thyra_SpmdVectorBase.hpp"
16 #include "Thyra_EpetraLinearOp.hpp"
19 # include "Epetra_MpiComm.h"
21 #include "Epetra_SerialComm.h"
22 #include "Epetra_Vector.h"
25 # include "Teuchos_DefaultMpiComm.hpp"
27 #include "Teuchos_DefaultSerialComm.hpp"
39 : useTranspose_(false),
41 range_(thyraOp->range()),
42 domain_(thyraOp->domain()),
43 comm_(getEpetraComm(*thyraOp)),
46 label_(thyraOp->description())
54 using Teuchos::rcpFromPtr;
55 using Teuchos::rcp_dynamic_cast;
57 const int numVecs = x.NumVectors();
60 "epetraToThyra does not work with MV dimension != 1");
63 castOrCreateNonconstProductVectorBase(rcpFromPtr(thyraVec));
71 const int numBlocks = prodThyraVec->productSpace()->numBlocks();
72 for (
int b = 0; b < numBlocks; ++b) {
78 const int localNumElems = spmd_vs_b->localSubDim();
79 for (
int i=0; i < localNumElems; ++i) {
80 thyraData[i] = epetraData[i+offset];
82 offset += localNumElems;
92 using Teuchos::rcpFromRef;
93 using Teuchos::rcp_dynamic_cast;
95 const int numVecs = x.NumVectors();
98 "epetraToThyra does not work with MV dimension != 1");
101 castOrCreateProductVectorBase(rcpFromRef(thyraVec));
107 const int numBlocks = prodThyraVec->productSpace()->numBlocks();
108 for (
int b = 0; b < numBlocks; ++b) {
114 const int localNumElems = spmd_vs_b->localSubDim();
115 for (
int i=0; i < localNumElems; ++i) {
116 epetraData[i+offset] = thyraData[i];
118 offset += localNumElems;
132 opRange = ( !useTranspose_ ? range_ : domain_ ),
133 opDomain = ( !useTranspose_ ? domain_ : range_ );
153 "EpetraOperatorWrapper::ApplyInverse not implemented");
161 "EpetraOperatorWrapper::NormInf not implemated");
174 using Teuchos::rcp_dynamic_cast;
177 using Teuchos::MpiComm;
186 vs = prod_vs->getBlock(0);
200 Thyra::makeEpetraWrapper(
const RCP<
const LinearOpBase<double> > &thyraOp)
Create an explicit detached mutable (non-const) view of all of the local elements on this process of ...
virtual RCP< const VectorSpaceBase< Scalar > > range() const =0
Return a smart pointer for the range space for this operator.
void copyEpetraIntoThyra(const Epetra_MultiVector &x, const Ptr< VectorBase< double > > &thyraVec) const
EpetraOperatorWrapper(const RCP< const LinearOpBase< double > > &thyraOp)
RCP< const Epetra_Map > get_Epetra_Map(const VectorSpaceBase< double > &vs, const RCP< const Epetra_Comm > &comm)
Get (or create) an Epetra_Map object given an VectorSpaceBase object an optionally an extra Epetra_Co...
#define TEUCHOS_TEST_FOR_EXCEPTION(throw_exception_test, Exception, msg)
Use the non-transposed operator.
Use the transposed operator with complex-conjugate clements (same as TRANS for real scalar types)...
TEUCHOS_DEPRECATED RCP< T > rcp(T *p, Dealloc_T dealloc, bool owns_mem)
Abstract interface for finite-dimensional dense vectors.
RCP< const EpetraLinearOp > epetraLinearOp(const RCP< const 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)
Dynamically allocate a nonconst EpetraLinearOp to wrap a const Epetra_Operator object.
int Apply(const Epetra_MultiVector &X, Epetra_MultiVector &Y) const
RCP< const Epetra_Comm > get_Epetra_Comm(const Teuchos::Comm< Ordinal > &comm)
Get (or create) and Epetra_Comm given a Teuchos::Comm object.
void copyThyraIntoEpetra(const VectorBase< double > &thyraVec, Epetra_MultiVector &x) const
bool nonnull(const boost::shared_ptr< T > &p)
#define TEUCHOS_UNREACHABLE_RETURN(dummyReturnVal)
int ApplyInverse(const Epetra_MultiVector &X, Epetra_MultiVector &Y) const
Create an explicit detached non-mutable (const) view of all of the local elements on this process of ...
Base abstract VectorSpaceBase class for all SPMD-based vector spaces.