ROL
Public Member Functions | Private Types | Private Attributes | List of all members
TridiagonalToeplitzOperator< Real > Class Template Reference
+ Inheritance diagram for TridiagonalToeplitzOperator< Real >:

Public Member Functions

 TridiagonalToeplitzOperator (Real &a, Real &b, Real &c)
 
void apply (V &Hv, const V &v, Real &tol) const
 Apply linear operator. More...
 
void applyInverse (V &Hv, const V &v, Real &tol) const
 Apply inverse of linear operator. More...
 
 TridiagonalToeplitzOperator (Real &a, Real &b, Real &c)
 
void apply (V &Hv, const V &v, Real &tol) const
 Apply linear operator. More...
 
void applyInverse (V &Hv, const V &v, Real &tol) const
 Apply inverse of linear operator. More...
 
- Public Member Functions inherited from ROL::LinearOperator< Real >
virtual ~LinearOperator ()
 
virtual void update (const Vector< Real > &x, bool flag=true, int iter=-1)
 Update linear operator. More...
 
virtual void applyAdjoint (Vector< Real > &Hv, const Vector< Real > &v, Real &tol) const
 Apply adjoint of linear operator. More...
 
virtual void applyAdjointInverse (Vector< Real > &Hv, const Vector< Real > &v, Real &tol) const
 Apply adjoint of the inverse linear operator. More...
 

Private Types

typedef std::vector< Real > vector
 
typedef ROL::Vector< Real > V
 
typedef ROL::StdVector< Real > SV
 
typedef vector::size_type uint
 
typedef std::vector< Real > vector
 
typedef ROL::Vector< Real > V
 
typedef ROL::StdVector< Real > SV
 
typedef vector::size_type uint
 

Private Attributes

Real a_
 
Real b_
 
Real c_
 
ROL::LAPACK< int, Real > lapack_
 

Detailed Description

template<class Real>
class TridiagonalToeplitzOperator< Real >

Definition at line 72 of file step/krylov/test_01.cpp.

Member Typedef Documentation

template<class Real>
typedef std::vector<Real> TridiagonalToeplitzOperator< Real >::vector
private

Definition at line 74 of file step/krylov/test_01.cpp.

template<class Real>
typedef ROL::Vector<Real> TridiagonalToeplitzOperator< Real >::V
private

Definition at line 75 of file step/krylov/test_01.cpp.

template<class Real>
typedef ROL::StdVector<Real> TridiagonalToeplitzOperator< Real >::SV
private

Definition at line 76 of file step/krylov/test_01.cpp.

template<class Real>
typedef vector::size_type TridiagonalToeplitzOperator< Real >::uint
private

Definition at line 78 of file step/krylov/test_01.cpp.

template<class Real>
typedef std::vector<Real> TridiagonalToeplitzOperator< Real >::vector
private

Definition at line 73 of file step/krylov/test_03.cpp.

template<class Real>
typedef ROL::Vector<Real> TridiagonalToeplitzOperator< Real >::V
private

Definition at line 74 of file step/krylov/test_03.cpp.

template<class Real>
typedef ROL::StdVector<Real> TridiagonalToeplitzOperator< Real >::SV
private

Definition at line 75 of file step/krylov/test_03.cpp.

template<class Real>
typedef vector::size_type TridiagonalToeplitzOperator< Real >::uint
private

Definition at line 77 of file step/krylov/test_03.cpp.

Constructor & Destructor Documentation

template<class Real>
TridiagonalToeplitzOperator< Real >::TridiagonalToeplitzOperator ( Real &  a,
Real &  b,
Real &  c 
)
inline

Definition at line 90 of file step/krylov/test_01.cpp.

template<class Real>
TridiagonalToeplitzOperator< Real >::TridiagonalToeplitzOperator ( Real &  a,
Real &  b,
Real &  c 
)
inline

Definition at line 89 of file step/krylov/test_03.cpp.

Member Function Documentation

template<class Real>
void TridiagonalToeplitzOperator< Real >::apply ( V Hv,
const V v,
Real &  tol 
) const
inlinevirtual

Apply linear operator.

This function applies the linear operator to a vector.

Parameters
[out]Hvis the output vector.
[in]vis the input vector.
[in]tolis a tolerance for inexact linear operator application.

Implements ROL::LinearOperator< Real >.

Definition at line 93 of file step/krylov/test_01.cpp.

References TridiagonalToeplitzOperator< Real >::a_, TridiagonalToeplitzOperator< Real >::b_, TridiagonalToeplitzOperator< Real >::c_, and ROL::StdVector< Real, Element >::getVector().

Referenced by main().

template<class Real>
void TridiagonalToeplitzOperator< Real >::applyInverse ( V Hv,
const V v,
Real &  tol 
) const
inlinevirtual

Apply inverse of linear operator.

This function applies the inverse of linear operator to a vector.

Parameters
[out]Hvis the output vector.
[in]vis the input vector.
[in]tolis a tolerance for inexact linear operator application.

Reimplemented from ROL::LinearOperator< Real >.

Definition at line 116 of file step/krylov/test_01.cpp.

References TridiagonalToeplitzOperator< Real >::a_, TridiagonalToeplitzOperator< Real >::b_, TridiagonalToeplitzOperator< Real >::c_, ROL::StdVector< Real, Element >::getVector(), TridiagonalToeplitzOperator< Real >::lapack_, and ROL::Vector< Real >::set().

Referenced by main().

template<class Real>
void TridiagonalToeplitzOperator< Real >::apply ( V Hv,
const V v,
Real &  tol 
) const
inlinevirtual

Apply linear operator.

This function applies the linear operator to a vector.

Parameters
[out]Hvis the output vector.
[in]vis the input vector.
[in]tolis a tolerance for inexact linear operator application.

Implements ROL::LinearOperator< Real >.

Definition at line 92 of file step/krylov/test_03.cpp.

References TridiagonalToeplitzOperator< Real >::a_, TridiagonalToeplitzOperator< Real >::b_, TridiagonalToeplitzOperator< Real >::c_, and ROL::StdVector< Real, Element >::getVector().

template<class Real>
void TridiagonalToeplitzOperator< Real >::applyInverse ( V Hv,
const V v,
Real &  tol 
) const
inlinevirtual

Apply inverse of linear operator.

This function applies the inverse of linear operator to a vector.

Parameters
[out]Hvis the output vector.
[in]vis the input vector.
[in]tolis a tolerance for inexact linear operator application.

Reimplemented from ROL::LinearOperator< Real >.

Definition at line 113 of file step/krylov/test_03.cpp.

References TridiagonalToeplitzOperator< Real >::a_, TridiagonalToeplitzOperator< Real >::b_, TridiagonalToeplitzOperator< Real >::c_, ROL::StdVector< Real, Element >::getVector(), TridiagonalToeplitzOperator< Real >::lapack_, and ROL::Vector< Real >::set().

Member Data Documentation

template<class Real>
Real TridiagonalToeplitzOperator< Real >::a_
private
template<class Real>
Real TridiagonalToeplitzOperator< Real >::b_
private
template<class Real>
Real TridiagonalToeplitzOperator< Real >::c_
private
template<class Real>
ROL::LAPACK< int, Real > TridiagonalToeplitzOperator< Real >::lapack_
private

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