43 #include "Thyra_DefaultDiagonalLinearOpWithSolve.hpp" 
   48 #include "Epetra_RowMatrix.h" 
   49 #include "Epetra_Vector.h" 
   50 #include "Epetra_Map.h" 
   57   const LinearOpSourceBase<double> &fwdOpSrc
 
   60   using Teuchos::outArg;
 
   62     fwdOp = fwdOpSrc.getOp();
 
   64   if( ! (eFwdOp = dynamic_cast<const EpetraLinearOpBase*>(&*fwdOp)) )
 
   67   EOpTransp epetraFwdOpTransp;
 
   71     outArg(epetraFwdOpApplyAs), outArg(epetraFwdOpAdjointSupport) );
 
   72   if( !dynamic_cast<const Epetra_RowMatrix*>(&*epetraFwdOp) )
 
   81   return Teuchos::rcp(
new DefaultDiagonalLinearOpWithSolve<double>());
 
   86   const RCP<
const LinearOpSourceBase<double> >    &fwdOpSrc
 
   87   ,LinearOpWithSolveBase<double>                                   *Op
 
   88   ,
const ESupportSolveUse                                          
 
   91   using Teuchos::outArg;
 
   98   EOpTransp epetraFwdOpTransp;
 
  102     outArg(epetraFwdOpApplyAs), outArg(epetraFwdOpAdjointSupport) );
 
  103   const Epetra_RowMatrix &eRMOp  =
 
  105   const Epetra_Map &map = eRMOp.OperatorDomainMap();
 
  108   eRMOp.ExtractDiagonalCopy(*e_diag);
 
  113   Teuchos::set_extra_data<RCP<const LinearOpSourceBase<double> > >(
 
  114     fwdOpSrc, 
"Thyra::DiagonalEpetraLinearOpWithSolveFactory::fwdOpSrc",
 
  115     Teuchos::inOutArg(diag)
 
  118     Teuchos::rcp_implicit_cast<
const VectorBase<double> >(diag)
 
  125   LinearOpWithSolveBase<double>                               *Op
 
  126   ,
RCP<
const LinearOpSourceBase<double> >    *fwdOpSrc
 
  127   ,
RCP<
const PreconditionerBase<double> >    *prec
 
  128   ,
RCP<
const LinearOpSourceBase<double> >    *approxFwdOpSrc
 
  132   using Teuchos::get_extra_data;
 
  134   DefaultDiagonalLinearOpWithSolve<double>
 
  137     diag = diagOp.getDiag();
 
  141         get_extra_data<RCP<const LinearOpSourceBase<double> > >(
 
  142           diag,
"Thyra::DiagonalEpetraLinearOpWithSolveFactory::fwdOpSrc" 
void setParameterList(Teuchos::RCP< Teuchos::ParameterList > const ¶mList)
 
Teuchos::RCP< const Teuchos::ParameterList > getParameterList() const 
 
RCP< const VectorSpaceBase< double > > create_VectorSpace(const RCP< const Epetra_Map > &epetra_map)
Create an VectorSpaceBase object given an Epetra_Map object. 
 
Abstract base class for all LinearOpBase objects that can return an Epetra_Operator view of themselve...
 
bool isCompatible(const LinearOpSourceBase< double > &fwdOpSrc) const 
 
TEUCHOS_DEPRECATED RCP< T > rcp(T *p, Dealloc_T dealloc, bool owns_mem)
 
Teuchos::RCP< LinearOpWithSolveBase< double > > createOp() const 
 
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. 
 
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 
 
EAdjointEpetraOp
Determine if adjoints are supported on Epetra_Opeator or not. 
 
T_To & dyn_cast(T_From &from)
 
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...
 
void initializeOp(const Teuchos::RCP< const LinearOpSourceBase< double > > &fwdOpSrc, LinearOpWithSolveBase< double > *Op, const ESupportSolveUse supportSolveUse) const 
 
Teuchos::RCP< Teuchos::ParameterList > getNonconstParameterList()
 
Teuchos::RCP< Teuchos::ParameterList > unsetParameterList()
 
EApplyEpetraOpAs
Determine how the apply an Epetra_Operator as a linear operator. 
 
Teuchos::RCP< const Teuchos::ParameterList > getValidParameters() const 
 
#define TEUCHOS_TEST_FOR_EXCEPT(throw_exception_test)