Thyra  Version of the Day
Related Functions | List of all members

Concrete composite LinearOpBase subclass that creates an implicitly multiplied linear operator out of one or more constituent LinearOpBase objects. More...

#include <Thyra_DefaultMultipliedLinearOp_decl.hpp>

Inheritance diagram for Thyra::DefaultMultipliedLinearOp< Scalar >:
Inheritance graph
[legend]

Related Functions

(Note that these are not member functions.)

template<class Scalar >
RCP< DefaultMultipliedLinearOp< Scalar > > defaultMultipliedLinearOp ()
 Nonmember constructor. More...
 
template<class Scalar >
RCP< DefaultMultipliedLinearOp< Scalar > > defaultMultipliedLinearOp (const ArrayView< const RCP< LinearOpBase< Scalar > > > &Ops)
 Nonmember constructor. More...
 
template<class Scalar >
RCP< DefaultMultipliedLinearOp< Scalar > > defaultMultipliedLinearOp (const ArrayView< const RCP< const LinearOpBase< Scalar > > > &Ops)
 Nonmember constructor. More...
 
template<class Scalar >
RCP< LinearOpBase< Scalar > > nonconstMultiply (const RCP< LinearOpBase< Scalar > > &A, const RCP< LinearOpBase< Scalar > > &B, const std::string &M_label="")
 Form an implicit multiplication of two linear operators: M = A. More...
 
template<class Scalar >
RCP< const LinearOpBase< Scalar > > multiply (const RCP< const LinearOpBase< Scalar > > &A, const RCP< const LinearOpBase< Scalar > > &B, const std::string &M_label="")
 Form an implicit multiplication of two linear operators: M = A. More...
 
template<class Scalar >
RCP< const LinearOpBase< Scalar > > multiply (const RCP< const LinearOpBase< Scalar > > &A, const RCP< const LinearOpBase< Scalar > > &B, const RCP< const LinearOpBase< Scalar > > &C, const std::string &M_label="")
 Form an implicit multiplication of three linear operators: M = A * B * C. More...
 

Constructors/initializers/accessors

 DefaultMultipliedLinearOp ()
 Constructs to uninitialized. More...
 
void initialize (const ArrayView< const RCP< LinearOpBase< Scalar > > > &Ops)
 Initialize given a list of non-const linear operators. More...
 
void initialize (const ArrayView< const RCP< const LinearOpBase< Scalar > > > &Ops)
 Initialize given a list of const linear operators. More...
 
void uninitialize ()
 Set to uninitialized. More...
 

Overridden from MultipliedLinearOpBase

int numOps () const
 
bool opIsConst (const int k) const
 
RCP< LinearOpBase< Scalar > > getNonconstOp (const int k)
 
RCP< const LinearOpBase< Scalar > > getOp (const int k) const
 

Overridden from LinearOpBase

RCP< const VectorSpaceBase< Scalar > > range () const
 Returns this->getOp(0).range() if <t>this->numOps() > 0 and returns Teuchos::null otherwise. More...
 
RCP< const VectorSpaceBase< Scalar > > domain () const
 Returns this->getOp(this->numOps()-1).domain() if <t>this->numOps() > 0 and returns Teuchos::null otherwise. More...
 
RCP< const LinearOpBase< Scalar > > clone () const
 
bool opSupportedImpl (EOpTransp M_trans) const
 Returns true only if all constituent operators support M_trans. More...
 
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 DefaultMultipliedLinearOp along with the overall dimensions and the number of constituent operators. More...
 
void describe (Teuchos::FancyOStream &out, const Teuchos::EVerbosityLevel verbLevel) const
 Prints the details about the constituent linear operators. More...
 

Additional Inherited Members

- Public Member Functions inherited from Thyra::MultipliedLinearOpBase< Scalar >
- 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...
 
- Protected Member Functions inherited from Thyra::LinearOpBase< Scalar >

Detailed Description

template<class Scalar>
class Thyra::DefaultMultipliedLinearOp< Scalar >

Concrete composite LinearOpBase subclass that creates an implicitly multiplied linear operator out of one or more constituent LinearOpBase objects.

This class represents a multiplied linear operator M of the form:

M = Op[0] * Op[1] * ... * Op[numOps-1]

where Op[] is an array of numOps LinearOp objects. Of course the operator M is not constructed explicitly but instead just applies the constituent linear operators accordingly using temporaries.

In other words, this class defines apply() as:

y = alpha*M*x + beta*y
  = alpha * ( Op[0] * ( Op[1] * ( .... ( Op[numOps-1] * x ) ... ) ) ) + beta * y

for the case where M_trans==NOTRANS and as:

y = alpha*M'*x + beta*y
  = alpha * ( Op[numOps-1]' * ( .... ( Op[1]' * ( Op[0]' * x ) ) ... ) ) + beta * y

for the case where real_trans(M_trans)!=NOTRANS (where the transpose ' either defines TRANS or CONJTRANS).

Constructing a multiplied operator is easy. For example, suppose one wants to construct the multiplied operator D = A * B' * C. To do so one would do:

template<class Scalar>
void constructD(
const RCP<const Thyra::LinearOpBase<Scalar> > &A,
const RCP<const Thyra::LinearOpBase<Scalar> > &B,
const RCP<const Thyra::LinearOpBase<Scalar> > &C,
const Ptr<RCP<const Thyra::LinearOpBase<Scalar> > > &D
)
{
typedef RCP<const Thyra::LinearOpBase<Scalar> > LOB;
*D = Teuchos::rcp(
Teuchos::tuple<LOB>(A, adjoin(B), C)()
)
);
}

Rather than calling the constructor directly, consider using the non-member helper functions described here.

Definition at line 120 of file Thyra_DefaultMultipliedLinearOp_decl.hpp.

Constructor & Destructor Documentation

◆ DefaultMultipliedLinearOp()

template<class Scalar >
Thyra::DefaultMultipliedLinearOp< Scalar >::DefaultMultipliedLinearOp ( )

Constructs to uninitialized.

Postconditions:

Definition at line 93 of file Thyra_DefaultMultipliedLinearOp_def.hpp.

Member Function Documentation

◆ initialize() [1/2]

template<class Scalar >
void Thyra::DefaultMultipliedLinearOp< Scalar >::initialize ( const ArrayView< const RCP< LinearOpBase< Scalar > > > &  Ops)

Initialize given a list of non-const linear operators.

Parameters
Ops[in] Array (length numOps) of constituent linear operators and their aggregated default definitions of the non-transposed operator.

Preconditions:

  • numOps > 0
  • Ops != NULL
  • Ops[k].op().get()!=NULL, for k=0...numOps-1

Postconditions:

  • this->numOps()==numOps
  • this->getOp(k).op().get()==Ops[k].op().get(), for k=0...numOps-1

Definition at line 98 of file Thyra_DefaultMultipliedLinearOp_def.hpp.

◆ initialize() [2/2]

template<class Scalar >
void Thyra::DefaultMultipliedLinearOp< Scalar >::initialize ( const ArrayView< const RCP< const LinearOpBase< Scalar > > > &  Ops)

Initialize given a list of const linear operators.

Parameters
Ops[in] Array (length numOps) of constituent linear operators and their aggregated default definitions of the non-transposed operator.

Preconditions:

  • numOps > 0
  • Ops != NULL
  • Ops[k].op().get()!=NULL, for k=0...numOps-1

Postconditions:

  • this->numOps()==numOps
  • this->getOp(k).op().get()==Ops[k].op().get(), for k=0...numOps-1

Definition at line 111 of file Thyra_DefaultMultipliedLinearOp_def.hpp.

◆ uninitialize()

template<class Scalar >
void Thyra::DefaultMultipliedLinearOp< Scalar >::uninitialize ( )

Set to uninitialized.

Postconditions:

Definition at line 124 of file Thyra_DefaultMultipliedLinearOp_def.hpp.

◆ numOps()

template<class Scalar >
int Thyra::DefaultMultipliedLinearOp< Scalar >::numOps ( ) const
virtual

◆ opIsConst()

template<class Scalar >
bool Thyra::DefaultMultipliedLinearOp< Scalar >::opIsConst ( const int  k) const
virtual

◆ getNonconstOp()

template<class Scalar >
RCP< LinearOpBase< Scalar > > Thyra::DefaultMultipliedLinearOp< Scalar >::getNonconstOp ( const int  k)
virtual

◆ getOp()

template<class Scalar >
RCP< const LinearOpBase< Scalar > > Thyra::DefaultMultipliedLinearOp< Scalar >::getOp ( const int  k) const
virtual

◆ range()

template<class Scalar >
RCP< const VectorSpaceBase< Scalar > > Thyra::DefaultMultipliedLinearOp< Scalar >::range ( ) const
virtual

Returns this->getOp(0).range() if <t>this->numOps() > 0 and returns Teuchos::null otherwise.

Implements Thyra::LinearOpBase< Scalar >.

Definition at line 178 of file Thyra_DefaultMultipliedLinearOp_def.hpp.

◆ domain()

template<class Scalar >
RCP< const VectorSpaceBase< Scalar > > Thyra::DefaultMultipliedLinearOp< Scalar >::domain ( ) const
virtual

Returns this->getOp(this->numOps()-1).domain() if <t>this->numOps() > 0 and returns Teuchos::null otherwise.

Implements Thyra::LinearOpBase< Scalar >.

Definition at line 189 of file Thyra_DefaultMultipliedLinearOp_def.hpp.

◆ clone()

template<class Scalar >
RCP< const LinearOpBase< Scalar > > Thyra::DefaultMultipliedLinearOp< Scalar >::clone ( ) const
virtual

Reimplemented from Thyra::LinearOpBase< Scalar >.

Definition at line 200 of file Thyra_DefaultMultipliedLinearOp_def.hpp.

◆ description()

template<class Scalar >
std::string Thyra::DefaultMultipliedLinearOp< Scalar >::description ( ) const

Prints just the name DefaultMultipliedLinearOp along with the overall dimensions and the number of constituent operators.

Definition at line 210 of file Thyra_DefaultMultipliedLinearOp_def.hpp.

◆ describe()

template<class Scalar >
void Thyra::DefaultMultipliedLinearOp< Scalar >::describe ( Teuchos::FancyOStream &  out,
const Teuchos::EVerbosityLevel  verbLevel 
) const

Prints the details about the constituent linear operators.

This function outputs different levels of detail based on the value passed in for verbLevel:

ToDo: Finish documentation!

Definition at line 220 of file Thyra_DefaultMultipliedLinearOp_def.hpp.

◆ opSupportedImpl()

template<class Scalar >
bool Thyra::DefaultMultipliedLinearOp< Scalar >::opSupportedImpl ( EOpTransp  M_trans) const
protectedvirtual

Returns true only if all constituent operators support M_trans.

Implements Thyra::LinearOpBase< Scalar >.

Definition at line 262 of file Thyra_DefaultMultipliedLinearOp_def.hpp.

◆ applyImpl()

template<class Scalar >
void Thyra::DefaultMultipliedLinearOp< Scalar >::applyImpl ( const EOpTransp  M_trans,
const MultiVectorBase< Scalar > &  X,
const Ptr< MultiVectorBase< Scalar > > &  Y,
const Scalar  alpha,
const Scalar  beta 
) const
protectedvirtual

Friends And Related Function Documentation

◆ defaultMultipliedLinearOp() [1/3]

template<class Scalar >
RCP< DefaultMultipliedLinearOp< Scalar > > defaultMultipliedLinearOp ( )
related

Nonmember constructor.

Definition at line 286 of file Thyra_DefaultMultipliedLinearOp_decl.hpp.

◆ defaultMultipliedLinearOp() [2/3]

template<class Scalar >
RCP< DefaultMultipliedLinearOp< Scalar > > defaultMultipliedLinearOp ( const ArrayView< const RCP< LinearOpBase< Scalar > > > &  Ops)
related

Nonmember constructor.

Definition at line 298 of file Thyra_DefaultMultipliedLinearOp_decl.hpp.

◆ defaultMultipliedLinearOp() [3/3]

template<class Scalar >
RCP< DefaultMultipliedLinearOp< Scalar > > defaultMultipliedLinearOp ( const ArrayView< const RCP< const LinearOpBase< Scalar > > > &  Ops)
related

Nonmember constructor.

Definition at line 312 of file Thyra_DefaultMultipliedLinearOp_decl.hpp.

◆ nonconstMultiply()

template<class Scalar >
RCP< LinearOpBase< Scalar > > nonconstMultiply ( const RCP< LinearOpBase< Scalar > > &  A,
const RCP< LinearOpBase< Scalar > > &  B,
const std::string &  M_label = "" 
)
related

Form an implicit multiplication of two linear operators: M = A.

  • B.

◆ multiply() [1/2]

template<class Scalar >
RCP< const LinearOpBase< Scalar > > multiply ( const RCP< const LinearOpBase< Scalar > > &  A,
const RCP< const LinearOpBase< Scalar > > &  B,
const std::string &  M_label = "" 
)
related

Form an implicit multiplication of two linear operators: M = A.

  • B.

◆ multiply() [2/2]

template<class Scalar >
RCP< const LinearOpBase< Scalar > > multiply ( const RCP< const LinearOpBase< Scalar > > &  A,
const RCP< const LinearOpBase< Scalar > > &  B,
const RCP< const LinearOpBase< Scalar > > &  C,
const std::string &  M_label = "" 
)
related

Form an implicit multiplication of three linear operators: M = A * B * C.


The documentation for this class was generated from the following files: