Thyra Version of the Day
|
Represents a zero linear operator M = 0
.
More...
#include <Thyra_DefaultZeroLinearOp_decl.hpp>
Related Symbols | |
(Note that these are not member symbols.) | |
template<class Scalar > | |
RCP< const LinearOpBase< Scalar > > | zero (const RCP< const VectorSpaceBase< Scalar > > &range, const RCP< const VectorSpaceBase< Scalar > > &domain) |
Create a zero linear operator with given range and domain spaces. | |
template<class Scalar > | |
RCP< LinearOpBase< Scalar > > | nonconstZero (const RCP< const VectorSpaceBase< Scalar > > &range, const RCP< const VectorSpaceBase< Scalar > > &domain) |
Create a nonconst zero linear operator with given range and domain spaces. | |
![]() | |
template<class Scalar > | |
bool | isFullyUninitialized (const LinearOpBase< Scalar > &M) |
Determines if a linear operator is in the "Fully Uninitialized" state or not. | |
template<class Scalar > | |
bool | isPartiallyInitialized (const LinearOpBase< Scalar > &M) |
Determines if a linear operator is in the "Partially Initialized" state or not. | |
template<class Scalar > | |
bool | isFullyInitialized (const LinearOpBase< Scalar > &M) |
Determines if a linear operator is in the "Fully Initialized" state or not. | |
template<class Scalar > | |
bool | opSupported (const LinearOpBase< Scalar > &M, EOpTransp M_trans) |
Determines if an operation is supported for a single scalar type. | |
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(...) . | |
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>(...) . | |
Overridden from ScaledLinearOpBase | |
virtual bool | supportsScaleLeftImpl () const |
virtual bool | supportsScaleRightImpl () const |
virtual void | scaleLeftImpl (const VectorBase< Scalar > &) |
virtual void | scaleRightImpl (const VectorBase< Scalar > &) |
Constructors/initializers/accessors | |
DefaultZeroLinearOp () | |
Construct to uninitialized. | |
DefaultZeroLinearOp (const RCP< const VectorSpaceBase< Scalar > > &range, const RCP< const VectorSpaceBase< Scalar > > &domain) | |
void | initialize (const RCP< const VectorSpaceBase< Scalar > > &range, const RCP< const VectorSpaceBase< Scalar > > &domain) |
Initialize given a list of non-const linear operators. | |
void | uninitialize () |
Set to uninitialized. | |
Overridden from LinearOpBase | |
RCP< const VectorSpaceBase< Scalar > > | range () const |
Returns Teuchos::null if uninitialized. | |
RCP< const VectorSpaceBase< Scalar > > | domain () const |
Returns Teuchos::null if uninitialized. | |
RCP< const LinearOpBase< Scalar > > | clone () const |
bool | opSupportedImpl (EOpTransp M_trans) const |
Returns true . | |
void | applyImpl (const EOpTransp M_trans, const MultiVectorBase< Scalar > &X, const Ptr< MultiVectorBase< Scalar > > &Y, const Scalar alpha, const Scalar beta) const |
Overridden from Teuchos::Describable | |
std::string | description () const |
Prints just the name DefaultZeroLinearOp along with the overall dimensions. | |
Overridden from RowStatLinearOpBase | |
virtual bool | rowStatIsSupportedImpl (const RowStatLinearOpBaseUtils::ERowStat rowStat) const |
virtual void | getRowStatImpl (const RowStatLinearOpBaseUtils::ERowStat rowStat, const Teuchos::Ptr< VectorBase< Scalar > > &rowStatVec) const |
Additional Inherited Members | |
![]() | |
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 . | |
![]() | |
bool | rowStatIsSupported (const RowStatLinearOpBaseUtils::ERowStat rowStat) const |
Determine if a given row stat is supported. | |
void | getRowStat (const RowStatLinearOpBaseUtils::ERowStat rowStat, const Ptr< VectorBase< Scalar > > &rowStatVec) const |
Get some statistics about a supported row. | |
![]() | |
bool | supportsScaleLeft () const |
Determines if this objects supports left scaling. | |
bool | supportsScaleRight () const |
Determines if this objects supports right scaling. | |
void | scaleLeft (const VectorBase< Scalar > &row_scaling) |
Left scales operator with diagonal scaling operator. | |
void | scaleRight (const VectorBase< Scalar > &col_scaling) |
Right scales operator with diagonal scaling operator. | |
![]() | |
![]() | |
![]() |
Represents a zero linear operator M = 0
.
This class implements:
y = alpha*op(M)*x + beta*y => y = beta*y
Definition at line 71 of file Thyra_DefaultZeroLinearOp_decl.hpp.
Thyra::DefaultZeroLinearOp< Scalar >::DefaultZeroLinearOp | ( | ) |
Construct to uninitialized.
Postconditions:
this->range().get()==NULL
Definition at line 58 of file Thyra_DefaultZeroLinearOp_def.hpp.
Thyra::DefaultZeroLinearOp< Scalar >::DefaultZeroLinearOp | ( | const RCP< const VectorSpaceBase< Scalar > > & | range, |
const RCP< const VectorSpaceBase< Scalar > > & | domain ) |
Calls initialize()
.
Definition at line 63 of file Thyra_DefaultZeroLinearOp_def.hpp.
void Thyra::DefaultZeroLinearOp< Scalar >::initialize | ( | const RCP< const VectorSpaceBase< Scalar > > & | range, |
const RCP< const VectorSpaceBase< Scalar > > & | domain ) |
Initialize given a list of non-const linear operators.
range | [in] Range vector space. |
range | [in] Domain vector space. |
Preconditions:
range.get()!=NULL
domain.get()!=NULL
Postconditions:
Definition at line 73 of file Thyra_DefaultZeroLinearOp_def.hpp.
void Thyra::DefaultZeroLinearOp< Scalar >::uninitialize | ( | ) |
Set to uninitialized.
Postconditions:
this->range().get()==NULL
Definition at line 84 of file Thyra_DefaultZeroLinearOp_def.hpp.
|
virtual |
Returns Teuchos::null
if uninitialized.
Implements Thyra::LinearOpBase< Scalar >.
Definition at line 96 of file Thyra_DefaultZeroLinearOp_def.hpp.
|
virtual |
Returns Teuchos::null
if uninitialized.
Implements Thyra::LinearOpBase< Scalar >.
Definition at line 104 of file Thyra_DefaultZeroLinearOp_def.hpp.
|
virtual |
Reimplemented from Thyra::LinearOpBase< Scalar >.
Definition at line 112 of file Thyra_DefaultZeroLinearOp_def.hpp.
|
virtual |
Prints just the name DefaultZeroLinearOp
along with the overall dimensions.
Reimplemented from Teuchos::Describable.
Definition at line 125 of file Thyra_DefaultZeroLinearOp_def.hpp.
|
protectedvirtual |
Returns true
.
Implements Thyra::LinearOpBase< Scalar >.
Definition at line 145 of file Thyra_DefaultZeroLinearOp_def.hpp.
|
protectedvirtual |
Implements Thyra::LinearOpBase< Scalar >.
Definition at line 152 of file Thyra_DefaultZeroLinearOp_def.hpp.
|
protectedvirtual |
Implements Thyra::RowStatLinearOpBase< Scalar >.
Definition at line 172 of file Thyra_DefaultZeroLinearOp_def.hpp.
|
protectedvirtual |
Implements Thyra::RowStatLinearOpBase< Scalar >.
Definition at line 187 of file Thyra_DefaultZeroLinearOp_def.hpp.
|
inlineprotectedvirtual |
Implements Thyra::ScaledLinearOpBase< Scalar >.
Definition at line 188 of file Thyra_DefaultZeroLinearOp_decl.hpp.
|
inlineprotectedvirtual |
Implements Thyra::ScaledLinearOpBase< Scalar >.
Definition at line 192 of file Thyra_DefaultZeroLinearOp_decl.hpp.
|
inlineprotectedvirtual |
Implements Thyra::ScaledLinearOpBase< Scalar >.
Definition at line 196 of file Thyra_DefaultZeroLinearOp_decl.hpp.
|
inlineprotectedvirtual |
Implements Thyra::ScaledLinearOpBase< Scalar >.
Definition at line 200 of file Thyra_DefaultZeroLinearOp_decl.hpp.
|
related |
Create a zero linear operator with given range and domain spaces.
|
related |
Create a nonconst zero linear operator with given range and domain spaces.
This is to enable support for using the ScaledLinearOp interface. Which does nothing yet still requires nonconstant operators.