|
Thyra Version of the Day
|
Concrete Thyra::LinearOpBase subclass for Tpetra::Operator. More...
#include <Thyra_TpetraLinearOp_decl.hpp>

Related Symbols | |
(Note that these are not member symbols.) | |
| template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node > | |
| RCP< TpetraLinearOp< Scalar, LocalOrdinal, GlobalOrdinal, Node > > | tpetraLinearOp (const RCP< const VectorSpaceBase< Scalar > > &rangeSpace, const RCP< const VectorSpaceBase< Scalar > > &domainSpace, const RCP< Tpetra::Operator< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &tpetraOperator) |
| Nonmmeber constructor for TpetraLinearOp. | |
| template<class Scalar , class LocalOrdinal , class GlobalOrdinal , class Node > | |
| RCP< const TpetraLinearOp< Scalar, LocalOrdinal, GlobalOrdinal, Node > > | constTpetraLinearOp (const RCP< const VectorSpaceBase< Scalar > > &rangeSpace, const RCP< const VectorSpaceBase< Scalar > > &domainSpace, const RCP< const Tpetra::Operator< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &tpetraOperator) |
| Nonmmeber constructor for TpetraLinearOp. | |
Related Symbols 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. | |
| 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>(...). | |
Protected member functions overridden from RowStatLinearOpBase. | |
| virtual bool | rowStatIsSupportedImpl (const RowStatLinearOpBaseUtils::ERowStat rowStat) const |
| virtual void | getRowStatImpl (const RowStatLinearOpBaseUtils::ERowStat rowStat, const Ptr< VectorBase< Scalar > > &rowStatVec) const |
Constructors/initializers. | |
| TpetraLinearOp () | |
| Construct to uninitialized. | |
| void | initialize (const RCP< const VectorSpaceBase< Scalar > > &rangeSpace, const RCP< const VectorSpaceBase< Scalar > > &domainSpace, const RCP< Tpetra::Operator< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &tpetraOperator) |
| Initialize. | |
| void | constInitialize (const RCP< const VectorSpaceBase< Scalar > > &rangeSpace, const RCP< const VectorSpaceBase< Scalar > > &domainSpace, const RCP< const Tpetra::Operator< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &tpetraOperator) |
| Initialize. | |
| RCP< Tpetra::Operator< Scalar, LocalOrdinal, GlobalOrdinal, Node > > | getTpetraOperator () |
| Get embedded non-const Tpetra::Operator. | |
| RCP< const Tpetra::Operator< Scalar, LocalOrdinal, GlobalOrdinal, Node > > | getConstTpetraOperator () const |
| Get embedded const Tpetra::Operator. | |
Public Overridden functions from LinearOpBase. | |
| RCP< const Thyra::VectorSpaceBase< Scalar > > | range () const |
| RCP< const Thyra::VectorSpaceBase< Scalar > > | domain () const |
Protected Overridden functions from LinearOpBase. | |
| bool | opSupportedImpl (Thyra::EOpTransp M_trans) const |
| void | applyImpl (const Thyra::EOpTransp M_trans, const Thyra::MultiVectorBase< Scalar > &X_in, const Teuchos::Ptr< Thyra::MultiVectorBase< Scalar > > &Y_inout, const Scalar alpha, const Scalar beta) const |
Protected member functions overridden from ScaledLinearOpBase. | |
| virtual bool | supportsScaleLeftImpl () const |
| virtual bool | supportsScaleRightImpl () const |
| virtual void | scaleLeftImpl (const VectorBase< Scalar > &row_scaling) |
| virtual void | scaleRightImpl (const VectorBase< Scalar > &col_scaling) |
Additional Inherited Members | |
Public Member Functions inherited from Thyra::LinearOpDefaultBase< Scalar > | |
| std::string | description () const |
| Default description that gives the label, type, and dimenstion . | |
| void | describe (Teuchos::FancyOStream &out, const Teuchos::EVerbosityLevel verbLevel) const |
| Generates a default outputting for all linear operators. | |
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). | |
Public Member Functions inherited from Thyra::ScaledLinearOpBase< Scalar > | |
| 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. | |
Public Member Functions inherited from Thyra::RowStatLinearOpBase< Scalar > | |
| 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. | |
Protected Member Functions inherited from Thyra::LinearOpBase< Scalar > | |
Protected Member Functions inherited from Thyra::ScaledLinearOpBase< Scalar > | |
Protected Member Functions inherited from Thyra::RowStatLinearOpBase< Scalar > | |
Concrete Thyra::LinearOpBase subclass for Tpetra::Operator.
Definition at line 41 of file Thyra_TpetraLinearOp_decl.hpp.
| Thyra::TpetraLinearOp< Scalar, LocalOrdinal, GlobalOrdinal, Node >::TpetraLinearOp | ( | ) |
Construct to uninitialized.
Definition at line 107 of file Thyra_TpetraLinearOp_def.hpp.
| void Thyra::TpetraLinearOp< Scalar, LocalOrdinal, GlobalOrdinal, Node >::initialize | ( | const RCP< const VectorSpaceBase< Scalar > > & | rangeSpace, |
| const RCP< const VectorSpaceBase< Scalar > > & | domainSpace, | ||
| const RCP< Tpetra::Operator< Scalar, LocalOrdinal, GlobalOrdinal, Node > > & | tpetraOperator | ||
| ) |
Initialize.
Definition at line 112 of file Thyra_TpetraLinearOp_def.hpp.
| void Thyra::TpetraLinearOp< Scalar, LocalOrdinal, GlobalOrdinal, Node >::constInitialize | ( | const RCP< const VectorSpaceBase< Scalar > > & | rangeSpace, |
| const RCP< const VectorSpaceBase< Scalar > > & | domainSpace, | ||
| const RCP< const Tpetra::Operator< Scalar, LocalOrdinal, GlobalOrdinal, Node > > & | tpetraOperator | ||
| ) |
Initialize.
Definition at line 123 of file Thyra_TpetraLinearOp_def.hpp.
| RCP< Tpetra::Operator< Scalar, LocalOrdinal, GlobalOrdinal, Node > > Thyra::TpetraLinearOp< Scalar, LocalOrdinal, GlobalOrdinal, Node >::getTpetraOperator | ( | ) |
Get embedded non-const Tpetra::Operator.
Definition at line 135 of file Thyra_TpetraLinearOp_def.hpp.
| RCP< const Tpetra::Operator< Scalar, LocalOrdinal, GlobalOrdinal, Node > > Thyra::TpetraLinearOp< Scalar, LocalOrdinal, GlobalOrdinal, Node >::getConstTpetraOperator | ( | ) | const |
Get embedded const Tpetra::Operator.
Definition at line 143 of file Thyra_TpetraLinearOp_def.hpp.
|
virtual |
Implements Thyra::LinearOpBase< Scalar >.
Definition at line 154 of file Thyra_TpetraLinearOp_def.hpp.
|
virtual |
Implements Thyra::LinearOpBase< Scalar >.
Definition at line 162 of file Thyra_TpetraLinearOp_def.hpp.
|
protectedvirtual |
Implements Thyra::LinearOpBase< Scalar >.
Definition at line 220 of file Thyra_TpetraLinearOp_def.hpp.
|
protectedvirtual |
Implements Thyra::LinearOpBase< Scalar >.
Definition at line 240 of file Thyra_TpetraLinearOp_def.hpp.
|
protectedvirtual |
Implements Thyra::ScaledLinearOpBase< Scalar >.
Definition at line 277 of file Thyra_TpetraLinearOp_def.hpp.
|
protectedvirtual |
Implements Thyra::ScaledLinearOpBase< Scalar >.
Definition at line 284 of file Thyra_TpetraLinearOp_def.hpp.
|
protectedvirtual |
Implements Thyra::ScaledLinearOpBase< Scalar >.
Definition at line 292 of file Thyra_TpetraLinearOp_def.hpp.
|
protectedvirtual |
Implements Thyra::ScaledLinearOpBase< Scalar >.
Definition at line 310 of file Thyra_TpetraLinearOp_def.hpp.
|
protectedvirtual |
Implements Thyra::RowStatLinearOpBase< Scalar >.
Definition at line 329 of file Thyra_TpetraLinearOp_def.hpp.
|
protectedvirtual |
Implements Thyra::RowStatLinearOpBase< Scalar >.
Definition at line 348 of file Thyra_TpetraLinearOp_def.hpp.
|
related |
Nonmmeber constructor for TpetraLinearOp.
Definition at line 197 of file Thyra_TpetraLinearOp_decl.hpp.
|
related |
Nonmmeber constructor for TpetraLinearOp.
Definition at line 216 of file Thyra_TpetraLinearOp_decl.hpp.