Thyra  Version of the Day
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Groups Pages
Public Member Functions | Protected Member Functions | List of all members
ExampleTridiagSerialLinearOp< Scalar > Class Template Reference

Simple example subclass for serial tridiagonal matrices. More...

#include <ExampleTridiagSerialLinearOp.hpp>

Inheritance diagram for ExampleTridiagSerialLinearOp< Scalar >:
Inheritance graph
[legend]

Public Member Functions

 ExampleTridiagSerialLinearOp ()
 Construct to uninitialized. More...
 
 ExampleTridiagSerialLinearOp (const Thyra::Ordinal dim, const Teuchos::ArrayView< const Scalar > &lower, const Teuchos::ArrayView< const Scalar > &diag, const Teuchos::ArrayView< const Scalar > &upper)
 initialize(). More...
 
void initialize (const Thyra::Ordinal dim, const Teuchos::ArrayView< const Scalar > &lower, const Teuchos::ArrayView< const Scalar > &diag, const Teuchos::ArrayView< const Scalar > &upper)
 
- Public Member Functions inherited from Thyra::LinearOpDefaultBase< Scalar >
std::string description () const
 Default description that gives the label, type, and dimenstion . More...
 
void describe (Teuchos::FancyOStream &out, const Teuchos::EVerbosityLevel verbLevel) const
 Generates a default outputting for all linear operators. More...
 
- 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...
 
virtual RCP< const
LinearOpBase< Scalar > > 
clone () const
 Clone the linear operator object (if supported). More...
 

Protected Member Functions

Teuchos::RCP< const
Thyra::VectorSpaceBase< Scalar > > 
range () const
 
Teuchos::RCP< const
Thyra::VectorSpaceBase< Scalar > > 
domain () const
 
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 inherited from Thyra::LinearOpBase< Scalar >

Additional Inherited Members

Detailed Description

template<class Scalar>
class ExampleTridiagSerialLinearOp< Scalar >

Simple example subclass for serial tridiagonal matrices.

This subclass form a linear operator for tridiagonal matrices of the form:

\[ M= \left[\begin{array}{ccccc} d_{(1)} & u_{(1)} \\ l_{(1)} & d_{(2)} & u_{(2)} \\ & \ddots & \ddots & \ddots \\ & & l_{(n-2)} & d_{(n-1)} & u_{(n-1)} \\ & & & l_{(n-1)} & d_{(n)} \end{array}\right] \]

given the arrays lower[], diag[], and upper[] of dimension dim-1, dim and dim-1 respectively (see initialize()).

See the source code for this simple example by clicking on the link to the definition below.

Definition at line 79 of file ExampleTridiagSerialLinearOp.hpp.

Constructor & Destructor Documentation

template<class Scalar >
ExampleTridiagSerialLinearOp< Scalar >::ExampleTridiagSerialLinearOp ( )
inline

Construct to uninitialized.

Definition at line 84 of file ExampleTridiagSerialLinearOp.hpp.

template<class Scalar >
ExampleTridiagSerialLinearOp< Scalar >::ExampleTridiagSerialLinearOp ( const Thyra::Ordinal  dim,
const Teuchos::ArrayView< const Scalar > &  lower,
const Teuchos::ArrayView< const Scalar > &  diag,
const Teuchos::ArrayView< const Scalar > &  upper 
)
inline

initialize().

Definition at line 87 of file ExampleTridiagSerialLinearOp.hpp.

Member Function Documentation

template<class Scalar >
void ExampleTridiagSerialLinearOp< Scalar >::initialize ( const Thyra::Ordinal  dim,
const Teuchos::ArrayView< const Scalar > &  lower,
const Teuchos::ArrayView< const Scalar > &  diag,
const Teuchos::ArrayView< const Scalar > &  upper 
)
inline

Initialize given lower, diagonal and upper arrays of data.

Parameters
dim[in] Dimension of this matrix (must be >= 2).
lower[in] Array (length dim-1) of the lower diagonal elements
diag[in] Array (length dim) of the central diagonal elements
upper[in] Array (length dim-1) of the upper diagonal elements

Preconditions:

  • dim >= 2

Postconditions:

  • Should be obvious!

Definition at line 116 of file ExampleTridiagSerialLinearOp.hpp.

template<class Scalar >
Teuchos::RCP<const Thyra::VectorSpaceBase<Scalar> > ExampleTridiagSerialLinearOp< Scalar >::range ( ) const
inlineprotectedvirtual

Implements Thyra::LinearOpBase< Scalar >.

Definition at line 135 of file ExampleTridiagSerialLinearOp.hpp.

template<class Scalar >
Teuchos::RCP<const Thyra::VectorSpaceBase<Scalar> > ExampleTridiagSerialLinearOp< Scalar >::domain ( ) const
inlineprotectedvirtual

Implements Thyra::LinearOpBase< Scalar >.

Definition at line 139 of file ExampleTridiagSerialLinearOp.hpp.

template<class Scalar >
bool ExampleTridiagSerialLinearOp< Scalar >::opSupportedImpl ( Thyra::EOpTransp  M_trans) const
inlineprotectedvirtual

Implements Thyra::LinearOpBase< Scalar >.

Definition at line 143 of file ExampleTridiagSerialLinearOp.hpp.

template<class Scalar >
void ExampleTridiagSerialLinearOp< Scalar >::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
protectedvirtual

Implements Thyra::LinearOpBase< Scalar >.

Definition at line 166 of file ExampleTridiagSerialLinearOp.hpp.


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