ROL
Public Member Functions | Private Types | Private Attributes | List of all members
ROL::LinearOperatorSum< Real > Class Template Reference

#include <ROL_LinearOperatorSum.hpp>

+ Inheritance diagram for ROL::LinearOperatorSum< Real >:

Public Member Functions

 LinearOperatorSum (ROL::Ptr< OP > &A, ROL::Ptr< OP > &B, ROL::Ptr< V > &scratch)
 
 LinearOperatorSum (ROL::Ptr< OP > &A, ROL::Ptr< OP > &B, ROL::Ptr< OP > &C, ROL::Ptr< V > &scratch)
 
virtual void update (const Vector< Real > &x, bool flag=true, int iter=-1)
 Update linear operator.
 
virtual void apply (Vector< Real > &Hv, const Vector< Real > &v, Real &tol) const
 Apply linear operator.
 
virtual void applyInverse (Vector< Real > &Hv, const Vector< Real > &v, Real &tol) const
 Apply inverse of linear operator.
 
- Public Member Functions inherited from ROL::LinearOperator< Real >
virtual ~LinearOperator ()
 
virtual void applyAdjoint (Vector< Real > &Hv, const Vector< Real > &v, Real &tol) const
 Apply adjoint of linear operator.
 
virtual void applyAdjointInverse (Vector< Real > &Hv, const Vector< Real > &v, Real &tol) const
 Apply adjoint of the inverse linear operator.
 

Private Types

typedef Vector< Real > V
 
typedef LinearOperator< Real > OP
 
typedef std::vector< ROL::Ptr< OP > >::size_type size_type
 

Private Attributes

ROL::Ptr< std::vector< ROL::Ptr< OP > > > ops_
 
ROL::Ptr< Vscratch_
 

Detailed Description

template<class Real>
class ROL::LinearOperatorSum< Real >

\brief Provides the interface to sum of linear operators applied to a vector

Definition at line 59 of file ROL_LinearOperatorSum.hpp.

Member Typedef Documentation

◆ V

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

Definition at line 61 of file ROL_LinearOperatorSum.hpp.

◆ OP

template<class Real >
typedef LinearOperator<Real> ROL::LinearOperatorSum< Real >::OP
private

Definition at line 62 of file ROL_LinearOperatorSum.hpp.

◆ size_type

template<class Real >
typedef std::vector<ROL::Ptr<OP>>::size_type ROL::LinearOperatorSum< Real >::size_type
private

Definition at line 64 of file ROL_LinearOperatorSum.hpp.

Constructor & Destructor Documentation

◆ LinearOperatorSum() [1/2]

template<class Real >
ROL::LinearOperatorSum< Real >::LinearOperatorSum ( ROL::Ptr< OP > & A,
ROL::Ptr< OP > & B,
ROL::Ptr< V > & scratch )
inline

Definition at line 73 of file ROL_LinearOperatorSum.hpp.

References ROL::LinearOperatorSum< Real >::ops_.

◆ LinearOperatorSum() [2/2]

template<class Real >
ROL::LinearOperatorSum< Real >::LinearOperatorSum ( ROL::Ptr< OP > & A,
ROL::Ptr< OP > & B,
ROL::Ptr< OP > & C,
ROL::Ptr< V > & scratch )
inline

Definition at line 82 of file ROL_LinearOperatorSum.hpp.

References ROL::LinearOperatorSum< Real >::ops_.

Member Function Documentation

◆ update()

template<class Real >
virtual void ROL::LinearOperatorSum< Real >::update ( const Vector< Real > & x,
bool flag = true,
int iter = -1 )
inlinevirtual

Update linear operator.

This function updates the linear operator at new iterations.

Parameters
[in]xis the new iterate.
[in]flagis true if the iterate has changed.
[in]iteris the outer algorithm iterations count.

Reimplemented from ROL::LinearOperator< Real >.

Definition at line 95 of file ROL_LinearOperatorSum.hpp.

References ROL::LinearOperatorSum< Real >::ops_.

◆ apply()

template<class Real >
virtual void ROL::LinearOperatorSum< Real >::apply ( Vector< Real > & Hv,
const Vector< Real > & 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 101 of file ROL_LinearOperatorSum.hpp.

References ROL::LinearOperatorSum< Real >::ops_, ROL::Vector< Real >::plus(), and ROL::LinearOperatorSum< Real >::scratch_.

◆ applyInverse()

template<class Real >
virtual void ROL::LinearOperatorSum< Real >::applyInverse ( Vector< Real > & Hv,
const Vector< Real > & 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 109 of file ROL_LinearOperatorSum.hpp.

Member Data Documentation

◆ ops_

template<class Real >
ROL::Ptr<std::vector<ROL::Ptr<OP> > > ROL::LinearOperatorSum< Real >::ops_
private

◆ scratch_

template<class Real >
ROL::Ptr<V> ROL::LinearOperatorSum< Real >::scratch_
private

Definition at line 69 of file ROL_LinearOperatorSum.hpp.

Referenced by ROL::LinearOperatorSum< Real >::apply().


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