42 #ifndef THYRA_LINEAR_OP_DECL_HPP
43 #define THYRA_LINEAR_OP_DECL_HPP
45 #include "Thyra_OperatorVectorTypes.hpp"
46 #include "Teuchos_Describable.hpp"
47 #include "Teuchos_ExpandScalarTypeMacros.hpp"
48 #include "Teuchos_PromotionTraits.hpp"
190 template<
class Scalar>
352 template<
class Scalar>
353 bool isFullyUninitialized(
const LinearOpBase<Scalar> &M );
361 template<
class Scalar>
362 bool isPartiallyInitialized(
const LinearOpBase<Scalar> &M );
370 template<
class Scalar>
371 bool isFullyInitialized(
const LinearOpBase<Scalar> &M );
378 template<
class Scalar>
380 bool opSupported(
const LinearOpBase<Scalar> &M,
EOpTransp M_trans );
387 template<
class Scalar>
389 const LinearOpBase<Scalar> &M,
391 const MultiVectorBase<Scalar> &X,
392 const Ptr<MultiVectorBase<Scalar> > &Y,
393 const Scalar alpha = static_cast<Scalar>(1.0),
394 const Scalar beta = static_cast<Scalar>(0.0)
406 const LinearOpBase<double> &M,
408 const MultiVectorBase<double> &X,
409 const Ptr<MultiVectorBase<double> > &Y,
410 const double alpha = 1.0,
411 const double beta = 0.0
423 template<
class Scalar>
425 bool Thyra::isFullyUninitialized(
const LinearOpBase<Scalar> &M )
431 template<
class Scalar>
432 bool Thyra::isPartiallyInitialized(
const LinearOpBase<Scalar> &M )
446 template<
class Scalar>
447 bool Thyra::isFullyInitialized(
const LinearOpBase<Scalar> &M )
461 template<
class Scalar>
463 bool Thyra::opSupported(
const LinearOpBase<Scalar> &M,
EOpTransp M_trans )
465 return M.opSupported(M_trans);
471 const LinearOpBase<double> &M,
473 const MultiVectorBase<double> &X,
474 const Ptr<MultiVectorBase<double> > &Y,
479 apply<double>(M, M_trans, X, Y, alpha, beta);
483 #endif // THYRA_LINEAR_OP_DECL_HPP
virtual bool opSupportedImpl(EOpTransp M_trans) const =0
Override in subclass.
bool is_null(const boost::shared_ptr< T > &p)
virtual RCP< const VectorSpaceBase< Scalar > > range() const =0
Return a smart pointer for the range space for this operator.
EOpTransp
Enumeration for determining how a linear operator is applied. `*.
virtual void applyImpl(const EOpTransp M_trans, const MultiVectorBase< Scalar > &X, const Ptr< MultiVectorBase< Scalar > > &Y, const Scalar alpha, const Scalar beta) const =0
Override in subclass.
Use the non-transposed operator.
Use the transposed operator with complex-conjugate clements (same as TRANS for real scalar types)...
bool opSupported(EOpTransp M_trans) const
Return if the M_trans operation of apply() is supported or not.
Use the non-transposed operator with complex-conjugate elements (same as NOTRANS for real scalar type...
Use the transposed operator.
Interface for a collection of column vectors called a multi-vector.
bool opSupported(const LinearOpBase< Scalar > &M, EOpTransp M_trans)
Determines if an operation is supported for a single scalar type.
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).
Base class for all linear operators.
virtual RCP< const VectorSpaceBase< Scalar > > domain() const =0
Return a smart pointer for the domain space for this operator.