Thyra
Version of the Day
|
Concrete Thyra::LinearOpBase subclass for Tpetra::Operator. More...
#include <Thyra_TpetraLinearOp_decl.hpp>
Related Functions | |
(Note that these are not member functions.) | |
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. More... | |
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. 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... | |
Constructors/initializers. | |
TpetraLinearOp () | |
Construct to uninitialized. More... | |
void | initialize (const RCP< const VectorSpaceBase< Scalar > > &rangeSpace, const RCP< const VectorSpaceBase< Scalar > > &domainSpace, const RCP< Tpetra::Operator< Scalar, LocalOrdinal, GlobalOrdinal, Node > > &tpetraOperator) |
Initialize. More... | |
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. More... | |
RCP< Tpetra::Operator< Scalar, LocalOrdinal, GlobalOrdinal, Node > > | getTpetraOperator () |
Get embedded non-const Tpetra::Operator. More... | |
RCP< const Tpetra::Operator < Scalar, LocalOrdinal, GlobalOrdinal, Node > > | getConstTpetraOperator () const |
Get embedded const Tpetra::Operator. More... | |
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) |
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 |
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 106 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 111 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 122 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 134 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 142 of file Thyra_TpetraLinearOp_def.hpp.
|
virtual |
Implements Thyra::LinearOpBase< Scalar >.
Definition at line 153 of file Thyra_TpetraLinearOp_def.hpp.
|
virtual |
Implements Thyra::LinearOpBase< Scalar >.
Definition at line 161 of file Thyra_TpetraLinearOp_def.hpp.
|
protectedvirtual |
Implements Thyra::LinearOpBase< Scalar >.
Definition at line 219 of file Thyra_TpetraLinearOp_def.hpp.
|
protectedvirtual |
Implements Thyra::LinearOpBase< Scalar >.
Definition at line 239 of file Thyra_TpetraLinearOp_def.hpp.
|
protectedvirtual |
Implements Thyra::ScaledLinearOpBase< Scalar >.
Definition at line 274 of file Thyra_TpetraLinearOp_def.hpp.
|
protectedvirtual |
Implements Thyra::ScaledLinearOpBase< Scalar >.
Definition at line 281 of file Thyra_TpetraLinearOp_def.hpp.
|
protectedvirtual |
Implements Thyra::ScaledLinearOpBase< Scalar >.
Definition at line 290 of file Thyra_TpetraLinearOp_def.hpp.
|
protectedvirtual |
Implements Thyra::ScaledLinearOpBase< Scalar >.
Definition at line 308 of file Thyra_TpetraLinearOp_def.hpp.
|
protectedvirtual |
Implements Thyra::RowStatLinearOpBase< Scalar >.
Definition at line 327 of file Thyra_TpetraLinearOp_def.hpp.
|
protectedvirtual |
Implements Thyra::RowStatLinearOpBase< Scalar >.
Definition at line 345 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.