Thyra
Version of the Day
|
Default concreate decorator subclass for a transpose/adjoint LinearOpWithSolveBase
object.
More...
#include <Thyra_DefaultAdjointLinearOpWithSolve_decl.hpp>
Constructors/initializers/accessors | |
DefaultAdjointLinearOpWithSolve () | |
Constructs to uninitialized. More... | |
void | initialize (const RCP< LinearOpWithSolveBase< Scalar > > &lows, const EOpTransp transp) |
Initialize with non-const LOWSB . More... | |
void | initialize (const RCP< const LinearOpWithSolveBase< Scalar > > &lows, const EOpTransp transp) |
Initialize with const LOWSB . More... | |
const RCP < LinearOpWithSolveBase < Scalar > > | getNonconstOp () |
Get the non-const underlying LOWSB object. More... | |
const RCP< const LinearOpWithSolveBase< Scalar > > | getOp () const |
Get the const underlying LOWSB object. More... | |
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 |
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 |
Additional Inherited Members | |
Public Member Functions inherited from Thyra::LinearOpWithSolveBase< Scalar > | |
bool | solveSupports (EOpTransp transp) const |
Return if solve() supports the argument transp . More... | |
bool | solveSupports (EOpTransp transp, const Ptr< const SolveCriteria< Scalar > > solveCriteria) const |
Return if solve() supports a given transpose and solve criteria specification. More... | |
bool | solveSupportsSolveMeasureType (EOpTransp transp, const SolveMeasureType &solveMeasureType) const |
Return if solve() supports the given the solve measure type. More... | |
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. More... | |
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. More... | |
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 . More... | |
virtual RCP< const LinearOpBase< Scalar > > | clone () const |
Clone the linear operator object (if supported). More... | |
Protected Member Functions inherited from Thyra::LinearOpWithSolveBase< Scalar > | |
virtual bool | solveSupportsNewImpl (EOpTransp, const Ptr< const SolveCriteria< Scalar > >) const |
Virtual implementation of solveSupports() . More... | |
Protected Member Functions inherited from Thyra::LinearOpBase< Scalar > | |
Related Functions inherited from Thyra::LinearOpWithSolveBase< Scalar > | |
template<class Scalar > | |
bool | solveSupports (const LinearOpWithSolveBase< Scalar > &A, const EOpTransp transp) |
Call solveSupports() as a non-member function. More... | |
template<class Scalar > | |
bool | solveSupports (const LinearOpWithSolveBase< Scalar > &A, const EOpTransp transp, const Ptr< const SolveCriteria< Scalar > > solveCriteria) |
Call solveSupports() as a non-member function. More... | |
template<class Scalar > | |
bool | solveSupportsSolveMeasureType (const LinearOpWithSolveBase< Scalar > &A, const EOpTransp transp, const SolveMeasureType &solveMeasureType) |
Call solveSupportsSolveMeasureType() as a non-member function. More... | |
template<class Scalar > | |
SolveStatus< Scalar > | solve (const LinearOpWithSolveBase< Scalar > &A, const EOpTransp A_trans, const MultiVectorBase< Scalar > &B, const Ptr< MultiVectorBase< Scalar > > &X, const Ptr< const SolveCriteria< Scalar > > solveCriteria=Teuchos::null) |
Call solve() as a non-member function. More... | |
template<class Scalar > | |
void | assertSolveSupports (const LinearOpWithSolveBase< Scalar > &lows, const EOpTransp M_trans, const Ptr< const SolveCriteria< Scalar > > solveCriteria=Teuchos::null) |
Assert that a LOWSB object supports a particular solve type. More... | |
Related Functions inherited from Thyra::LinearOpBase< Scalar > | |
template<class Scalar > | |
bool | isFullyUninitialized (const LinearOpBase< Scalar > &M) |
Determines if a linear operator is in the "Fully Uninitialized" state or not. More... | |
template<class Scalar > | |
bool | isPartiallyInitialized (const LinearOpBase< Scalar > &M) |
Determines if a linear operator is in the "Partially Initialized" state or not. More... | |
template<class Scalar > | |
bool | isFullyInitialized (const LinearOpBase< Scalar > &M) |
Determines if a linear operator is in the "Fully Initialized" state or not. More... | |
template<class Scalar > | |
bool | opSupported (const LinearOpBase< Scalar > &M, EOpTransp M_trans) |
Determines if an operation is supported for a single scalar type. More... | |
template<class Scalar > | |
void | apply (const LinearOpBase< Scalar > &M, const EOpTransp M_trans, const MultiVectorBase< Scalar > &X, const Ptr< MultiVectorBase< Scalar > > &Y, const Scalar alpha=static_cast< Scalar >(1.0), const Scalar beta=static_cast< Scalar >(0.0)) |
Non-member function call for M.apply(...) . More... | |
void | apply (const LinearOpBase< double > &M, const EOpTransp M_trans, const MultiVectorBase< double > &X, const Ptr< MultiVectorBase< double > > &Y, const double alpha=1.0, const double beta=0.0) |
Calls apply<double>(...) . More... | |
Default concreate decorator subclass for a transpose/adjoint LinearOpWithSolveBase
object.
ToDo: Finish Documentation!
Definition at line 27 of file Thyra_DefaultAdjointLinearOpWithSolve_decl.hpp.
Thyra::DefaultAdjointLinearOpWithSolve< Scalar >::DefaultAdjointLinearOpWithSolve | ( | ) |
Constructs to uninitialized.
Definition at line 25 of file Thyra_DefaultAdjointLinearOpWithSolve_def.hpp.
void Thyra::DefaultAdjointLinearOpWithSolve< Scalar >::initialize | ( | const RCP< LinearOpWithSolveBase< Scalar > > & | lows, |
const EOpTransp | transp | ||
) |
Initialize with non-const LOWSB .
Definition at line 31 of file Thyra_DefaultAdjointLinearOpWithSolve_def.hpp.
void Thyra::DefaultAdjointLinearOpWithSolve< Scalar >::initialize | ( | const RCP< const LinearOpWithSolveBase< Scalar > > & | lows, |
const EOpTransp | transp | ||
) |
Initialize with const LOWSB .
Definition at line 41 of file Thyra_DefaultAdjointLinearOpWithSolve_def.hpp.
const RCP< LinearOpWithSolveBase< Scalar > > Thyra::DefaultAdjointLinearOpWithSolve< Scalar >::getNonconstOp | ( | ) |
Get the non-const underlying LOWSB object.
Definition at line 52 of file Thyra_DefaultAdjointLinearOpWithSolve_def.hpp.
const RCP< const LinearOpWithSolveBase< Scalar > > Thyra::DefaultAdjointLinearOpWithSolve< Scalar >::getOp | ( | ) | const |
Get the const underlying LOWSB object.
Definition at line 60 of file Thyra_DefaultAdjointLinearOpWithSolve_def.hpp.
|
virtual |
Implements Thyra::LinearOpBase< Scalar >.
Definition at line 71 of file Thyra_DefaultAdjointLinearOpWithSolve_def.hpp.
|
virtual |
Implements Thyra::LinearOpBase< Scalar >.
Definition at line 80 of file Thyra_DefaultAdjointLinearOpWithSolve_def.hpp.
|
protectedvirtual |
Implements Thyra::LinearOpBase< Scalar >.
Definition at line 94 of file Thyra_DefaultAdjointLinearOpWithSolve_def.hpp.
|
protectedvirtual |
Implements Thyra::LinearOpBase< Scalar >.
Definition at line 102 of file Thyra_DefaultAdjointLinearOpWithSolve_def.hpp.
|
protectedvirtual |
Reimplemented from Thyra::LinearOpWithSolveBase< Scalar >.
Definition at line 119 of file Thyra_DefaultAdjointLinearOpWithSolve_def.hpp.
|
protectedvirtual |
Reimplemented from Thyra::LinearOpWithSolveBase< Scalar >.
Definition at line 126 of file Thyra_DefaultAdjointLinearOpWithSolve_def.hpp.
|
protectedvirtual |
Implements Thyra::LinearOpWithSolveBase< Scalar >.
Definition at line 137 of file Thyra_DefaultAdjointLinearOpWithSolve_def.hpp.