Thyra Version of the Day
Loading...
Searching...
No Matches
List of all members
Thyra::DefaultAdjointLinearOpWithSolve< Scalar > Class Template Reference

Default concreate decorator subclass for a transpose/adjoint LinearOpWithSolveBase object. More...

#include <Thyra_DefaultAdjointLinearOpWithSolve_decl.hpp>

Inheritance diagram for Thyra::DefaultAdjointLinearOpWithSolve< Scalar >:
Inheritance graph
[legend]

Overridden from LinearOpWithSolveBase

bool solveSupportsImpl (EOpTransp M_trans) const
 
bool solveSupportsSolveMeasureTypeImpl (EOpTransp M_trans, const SolveMeasureType &solveMeasureType) const
 
SolveStatus< Scalar > solveImpl (const EOpTransp transp, const MultiVectorBase< Scalar > &B, const Ptr< MultiVectorBase< Scalar > > &X, const Ptr< const SolveCriteria< Scalar > > solveCriteria) const
 

Constructors/initializers/accessors

 DefaultAdjointLinearOpWithSolve ()
 Constructs to uninitialized.
 
void initialize (const RCP< LinearOpWithSolveBase< Scalar > > &lows, const EOpTransp transp)
 Initialize with non-const LOWSB .
 
void initialize (const RCP< const LinearOpWithSolveBase< Scalar > > &lows, const EOpTransp transp)
 Initialize with const LOWSB .
 
const RCP< LinearOpWithSolveBase< Scalar > > getNonconstOp ()
 Get the non-const underlying LOWSB object.
 
const RCP< const LinearOpWithSolveBase< Scalar > > getOp () const
 Get the const underlying LOWSB object.
 

Overridden from LinearOpBase

RCP< const VectorSpaceBase< Scalar > > range () const
 
RCP< const VectorSpaceBase< Scalar > > domain () const
 
bool opSupportedImpl (EOpTransp M_trans) const
 
void applyImpl (const EOpTransp M_trans, const MultiVectorBase< Scalar > &X, const Ptr< MultiVectorBase< Scalar > > &Y, const Scalar alpha, const Scalar beta) const
 

Additional Inherited Members

- Public Member Functions inherited from Thyra::LinearOpWithSolveBase< Scalar >
bool solveSupports (EOpTransp transp) const
 Return if solve() supports the argument transp.
 
bool solveSupports (EOpTransp transp, const Ptr< const SolveCriteria< Scalar > > solveCriteria) const
 Return if solve() supports a given transpose and solve criteria specification.
 
bool solveSupportsSolveMeasureType (EOpTransp transp, const SolveMeasureType &solveMeasureType) const
 Return if solve() supports the given the solve measure type.
 
SolveStatus< Scalar > solve (const EOpTransp A_trans, const MultiVectorBase< Scalar > &B, const Ptr< MultiVectorBase< Scalar > > &X, const Ptr< const SolveCriteria< Scalar > > solveCriteria=Teuchos::null) const
 Request the solution of a block linear system.
 
- Public Member Functions inherited from Thyra::LinearOpBase< Scalar >
bool opSupported (EOpTransp M_trans) const
 Return if the M_trans operation of apply() is supported or not.
 
void apply (const EOpTransp M_trans, const MultiVectorBase< Scalar > &X, const Ptr< MultiVectorBase< Scalar > > &Y, const Scalar alpha, const Scalar beta) const
 Apply the linear operator to a multi-vector : Y = alpha*op(M)*X + beta*Y.
 
virtual RCP< const LinearOpBase< Scalar > > clone () const
 Clone the linear operator object (if supported).
 
- Protected Member Functions inherited from Thyra::LinearOpWithSolveBase< Scalar >
virtual bool solveSupportsNewImpl (EOpTransp, const Ptr< const SolveCriteria< Scalar > >) const
 Virtual implementation of solveSupports().
 
- Protected Member Functions inherited from Thyra::LinearOpBase< Scalar >

Detailed Description

template<class Scalar>
class Thyra::DefaultAdjointLinearOpWithSolve< Scalar >

Default concreate decorator subclass for a transpose/adjoint LinearOpWithSolveBase object.

ToDo: Finish Documentation!

Definition at line 60 of file Thyra_DefaultAdjointLinearOpWithSolve_decl.hpp.

Constructor & Destructor Documentation

◆ DefaultAdjointLinearOpWithSolve()

template<class Scalar >
Thyra::DefaultAdjointLinearOpWithSolve< Scalar >::DefaultAdjointLinearOpWithSolve

Constructs to uninitialized.

Definition at line 58 of file Thyra_DefaultAdjointLinearOpWithSolve_def.hpp.

Member Function Documentation

◆ initialize() [1/2]

template<class Scalar >
void Thyra::DefaultAdjointLinearOpWithSolve< Scalar >::initialize ( const RCP< LinearOpWithSolveBase< Scalar > > &  lows,
const EOpTransp  transp 
)

Initialize with non-const LOWSB .

Definition at line 64 of file Thyra_DefaultAdjointLinearOpWithSolve_def.hpp.

◆ initialize() [2/2]

template<class Scalar >
void Thyra::DefaultAdjointLinearOpWithSolve< Scalar >::initialize ( const RCP< const LinearOpWithSolveBase< Scalar > > &  lows,
const EOpTransp  transp 
)

Initialize with const LOWSB .

Definition at line 74 of file Thyra_DefaultAdjointLinearOpWithSolve_def.hpp.

◆ getNonconstOp()

template<class Scalar >
const RCP< LinearOpWithSolveBase< Scalar > > Thyra::DefaultAdjointLinearOpWithSolve< Scalar >::getNonconstOp

Get the non-const underlying LOWSB object.

Definition at line 85 of file Thyra_DefaultAdjointLinearOpWithSolve_def.hpp.

◆ getOp()

template<class Scalar >
const RCP< const LinearOpWithSolveBase< Scalar > > Thyra::DefaultAdjointLinearOpWithSolve< Scalar >::getOp

Get the const underlying LOWSB object.

Definition at line 93 of file Thyra_DefaultAdjointLinearOpWithSolve_def.hpp.

◆ range()

template<class Scalar >
RCP< const VectorSpaceBase< Scalar > > Thyra::DefaultAdjointLinearOpWithSolve< Scalar >::range
virtual

◆ domain()

template<class Scalar >
RCP< const VectorSpaceBase< Scalar > > Thyra::DefaultAdjointLinearOpWithSolve< Scalar >::domain
virtual

◆ opSupportedImpl()

template<class Scalar >
bool Thyra::DefaultAdjointLinearOpWithSolve< Scalar >::opSupportedImpl ( EOpTransp  M_trans) const
protectedvirtual

◆ applyImpl()

template<class Scalar >
void Thyra::DefaultAdjointLinearOpWithSolve< Scalar >::applyImpl ( const EOpTransp  M_trans,
const MultiVectorBase< Scalar > &  X,
const Ptr< MultiVectorBase< Scalar > > &  Y,
const Scalar  alpha,
const Scalar  beta 
) const
protectedvirtual

◆ solveSupportsImpl()

template<class Scalar >
bool Thyra::DefaultAdjointLinearOpWithSolve< Scalar >::solveSupportsImpl ( EOpTransp  M_trans) const
protectedvirtual

◆ solveSupportsSolveMeasureTypeImpl()

template<class Scalar >
bool Thyra::DefaultAdjointLinearOpWithSolve< Scalar >::solveSupportsSolveMeasureTypeImpl ( EOpTransp  M_trans,
const SolveMeasureType solveMeasureType 
) const
protectedvirtual

◆ solveImpl()

template<class Scalar >
SolveStatus< Scalar > Thyra::DefaultAdjointLinearOpWithSolve< Scalar >::solveImpl ( const EOpTransp  transp,
const MultiVectorBase< Scalar > &  B,
const Ptr< MultiVectorBase< Scalar > > &  X,
const Ptr< const SolveCriteria< Scalar > >  solveCriteria 
) const
protectedvirtual

The documentation for this class was generated from the following files: