10#include "Thyra_DiagonalEpetraLinearOpWithSolveFactory.hpp" 
   11#include "Thyra_DefaultDiagonalLinearOpWithSolve.hpp" 
   12#include "Thyra_EpetraLinearOp.hpp" 
   14#include "Teuchos_dyn_cast.hpp" 
   16#include "Epetra_RowMatrix.h" 
   17#include "Epetra_Vector.h" 
   18#include "Epetra_Map.h" 
   28  using Teuchos::outArg;
 
   30    fwdOp = fwdOpSrc.
getOp();
 
   39    outArg(epetraFwdOpApplyAs), outArg(epetraFwdOpAdjointSupport) );
 
 
   59  using Teuchos::outArg;
 
   70    outArg(epetraFwdOpApplyAs), outArg(epetraFwdOpAdjointSupport) );
 
   82    fwdOpSrc, 
"Thyra::DiagonalEpetraLinearOpWithSolveFactory::fwdOpSrc",
 
   83    Teuchos::inOutArg(diag)
 
 
  100  using Teuchos::get_extra_data;
 
  109        get_extra_data<RCP<const LinearOpSourceBase<double> > >(
 
  110          diag,
"Thyra::DiagonalEpetraLinearOpWithSolveFactory::fwdOpSrc" 
 
virtual const Epetra_Map & OperatorDomainMap() const=0
 
virtual int ExtractDiagonalCopy(Epetra_Vector &Diagonal) const=0
 
Concrete LinearOpWithSolveBase subclass for diagonal linear operators.
 
RCP< const VectorBase< Scalar > > getDiag() const
 
Teuchos::RCP< Teuchos::ParameterList > getNonconstParameterList()
 
void setParameterList(Teuchos::RCP< Teuchos::ParameterList > const ¶mList)
 
void initializeOp(const Teuchos::RCP< const LinearOpSourceBase< double > > &fwdOpSrc, LinearOpWithSolveBase< double > *Op, const ESupportSolveUse supportSolveUse) const
 
bool isCompatible(const LinearOpSourceBase< double > &fwdOpSrc) const
 
Teuchos::RCP< const Teuchos::ParameterList > getValidParameters() const
 
void uninitializeOp(LinearOpWithSolveBase< double > *Op, Teuchos::RCP< const LinearOpSourceBase< double > > *fwdOpSrc, Teuchos::RCP< const PreconditionerBase< double > > *prec, Teuchos::RCP< const LinearOpSourceBase< double > > *approxFwdOpSrc, ESupportSolveUse *supportSolveUse) const
Uninitialize a LinearOpWithSolveBase object and return its remembered forward linear operator and pot...
 
Teuchos::RCP< LinearOpWithSolveBase< double > > createOp() const
 
Teuchos::RCP< Teuchos::ParameterList > unsetParameterList()
 
Teuchos::RCP< const Teuchos::ParameterList > getParameterList() const
 
Abstract base class for all LinearOpBase objects that can return an Epetra_Operator view of themselve...
 
virtual void getEpetraOpView(const Ptr< RCP< const Epetra_Operator > > &epetraOp, const Ptr< EOpTransp > &epetraOpTransp, const Ptr< EApplyEpetraOpAs > &epetraOpApplyAs, const Ptr< EAdjointEpetraOp > &epetraOpAdjointSupport) const =0
Return a smart pointer to a const Epetra_Operator view of this object and how the object is applied t...
 
Base interface for objects that can return a linear operator.
 
virtual Teuchos::RCP< const LinearOpBase< Scalar > > getOp() const =0
Return a const left preconditioner linear operator if one is designed or targeted to be applied on th...
 
Base class for all linear operators that can support a high-level solve operation.
 
Simple interface class to access a precreated preconditioner as one or more linear operators objects ...
 
Abstract interface for finite-dimensional dense vectors.
 
EApplyEpetraOpAs
Determine how the apply an Epetra_Operator as a linear operator.
 
RCP< VectorBase< double > > create_Vector(const RCP< Epetra_Vector > &epetra_v, const RCP< const VectorSpaceBase< double > > &space=Teuchos::null)
Create a non-const VectorBase object from a non-const Epetra_Vector object.
 
RCP< const VectorSpaceBase< double > > create_VectorSpace(const RCP< const Epetra_Map > &epetra_map)
Create an VectorSpaceBase object given an Epetra_Map object.
 
EAdjointEpetraOp
Determine if adjoints are supported on Epetra_Opeator or not.
 
#define TEUCHOS_TEST_FOR_EXCEPT(throw_exception_test)
 
ESupportSolveUse
Enum that specifies how a LinearOpWithSolveBase object will be used for solves after it is constructe...
 
EOpTransp
Enumeration for determining how a linear operator is applied. `*.
 
T_To & dyn_cast(T_From &from)
 
TEUCHOS_DEPRECATED RCP< T > rcp(T *p, Dealloc_T dealloc, bool owns_mem)