Teko  Version of the Day
 All Classes Files Functions Variables Pages
Public Member Functions | Protected Attributes | List of all members
Teko::BlockLowerTriInverseOp Class Reference

This linear operator computes the inverse of a lower triangular matrix. More...

#include <Teko_BlockLowerTriInverseOp.hpp>

Inheritance diagram for Teko::BlockLowerTriInverseOp:
Inheritance graph
[legend]

Public Member Functions

 BlockLowerTriInverseOp (BlockedLinearOp &L, const std::vector< LinearOp > &invDiag)
 This constructor explicitly takes a lower triangular matrix and inverse diagonal operators and builds a forward substitution operator. More...
 
Inherited methods from Thyra::LinearOpBase
virtual VectorSpace range () const
 Range space of this operator. More...
 
virtual VectorSpace domain () const
 Domain space of this operator. More...
 
virtual void implicitApply (const BlockedMultiVector &x, BlockedMultiVector &y, const double alpha=1.0, const double beta=0.0) const
 Perform a matrix vector multiply with this operator. More...
 
- Public Member Functions inherited from Teko::BlockImplicitLinearOp
virtual void implicitApply (const Thyra::EOpTransp M_trans, const BlockedMultiVector &x, BlockedMultiVector &y, const double alpha=1.0, const double beta=0.0) const
 Perform a matrix vector multiply with this implicitly defined blocked operator. More...
 

Protected Attributes

const BlockedLinearOp L_
 operator $ L $ More...
 
std::vector< LinearOp > invDiag_
 (Approximate) Inverses of the diagonal operators More...
 
Teuchos::RCP< const
Thyra::ProductVectorSpaceBase
< double > > 
productRange_
 Range vector space. More...
 
Teuchos::RCP< const
Thyra::ProductVectorSpaceBase
< double > > 
productDomain_
 Domain vector space. More...
 

Additional Inherited Members

- Protected Member Functions inherited from Teko::BlockImplicitLinearOp
virtual bool opSupportedImpl (const Thyra::EOpTransp M_trans) const
 Functions required by Thyra::LinearOpBase. More...
 

Detailed Description

This linear operator computes the inverse of a lower triangular matrix.

This linear operator computes the inverse of a lower triangular matrix. This requires, the lower triangular blocks, as well as the inverse of the operators on the diagonal.

Definition at line 63 of file Teko_BlockLowerTriInverseOp.hpp.

Constructor & Destructor Documentation

Teko::BlockLowerTriInverseOp::BlockLowerTriInverseOp ( BlockedLinearOp &  L,
const std::vector< LinearOp > &  invDiag 
)

This constructor explicitly takes a lower triangular matrix and inverse diagonal operators and builds a forward substitution operator.

This constructor explicitly takes a lower triangular matrix and inverse diagonal operators and builds a forward substitution operator.

Parameters
[in]LLower triangular matrix object
[in]invDiagVector containing the inverse of the diagonal blocks

Definition at line 55 of file Teko_BlockLowerTriInverseOp.cpp.

Member Function Documentation

virtual VectorSpace Teko::BlockLowerTriInverseOp::range ( ) const
inlinevirtual

Range space of this operator.

Implements Teko::BlockImplicitLinearOp.

Definition at line 82 of file Teko_BlockLowerTriInverseOp.hpp.

virtual VectorSpace Teko::BlockLowerTriInverseOp::domain ( ) const
inlinevirtual

Domain space of this operator.

Implements Teko::BlockImplicitLinearOp.

Definition at line 85 of file Teko_BlockLowerTriInverseOp.hpp.

void Teko::BlockLowerTriInverseOp::implicitApply ( const BlockedMultiVector &  src,
BlockedMultiVector &  dst,
const double  alpha = 1.0,
const double  beta = 0.0 
) const
virtual

Perform a matrix vector multiply with this operator.

The apply function takes one vector as input and applies the inverse $ LDU $ decomposition. The result is returned in $y$. If this operator is reprsented as $M$ then $ y = \alpha M x + \beta y $ (ignoring conjugation!).

Parameters
[in]x
[in,out]y
[in]alpha(default=1)
[in]beta(default=0)

Implements Teko::BlockImplicitLinearOp.

Definition at line 86 of file Teko_BlockLowerTriInverseOp.cpp.

Member Data Documentation

const BlockedLinearOp Teko::BlockLowerTriInverseOp::L_
protected

operator $ L $

Definition at line 108 of file Teko_BlockLowerTriInverseOp.hpp.

std::vector<LinearOp> Teko::BlockLowerTriInverseOp::invDiag_
protected

(Approximate) Inverses of the diagonal operators

Definition at line 109 of file Teko_BlockLowerTriInverseOp.hpp.

Teuchos::RCP<const Thyra::ProductVectorSpaceBase<double> > Teko::BlockLowerTriInverseOp::productRange_
protected

Range vector space.

Definition at line 111 of file Teko_BlockLowerTriInverseOp.hpp.

Teuchos::RCP<const Thyra::ProductVectorSpaceBase<double> > Teko::BlockLowerTriInverseOp::productDomain_
protected

Domain vector space.

Definition at line 112 of file Teko_BlockLowerTriInverseOp.hpp.


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