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

Projects on to the null space of a linear constraint. More...

#include <ROL_NullSpaceOperator.hpp>

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

Public Member Functions

virtual ~NullSpaceOperator ()
 
 NullSpaceOperator (const Ptr< Constraint< Real >> &con, const Ptr< Vector< Real >> &dom, const Ptr< Vector< Real >> &ran)
 
virtual void apply (Vector< Real > &Hv, const Vector< Real > &v, Real &tol) const
 Apply linear operator. More...
 
void applyAdjoint (Vector< Real > &Hv, const Vector< Real > &v, Real &tol) const
 Apply adjoint of linear operator. More...
 
void applyInverse (Vector< Real > &Hv, const Vector< Real > &v, Real &tol) const
 Apply inverse of linear operator. More...
 
void applyAdjointInverse (Vector< Real > &Hv, const Vector< Real > &v, Real &tol) const
 Apply adjoint of the inverse 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...
 

Private Member Functions

void solveAugmentedSystem (Vector< Real > &v, Vector< Real > &b, Real &tol, bool refine=false) const
 

Private Attributes

const Ptr< Constraint< Real > > con_
 
const bool useInexact_
 
Ptr< LinearOperator< Real > > augsys_
 
Ptr< LinearOperator< Real > > augsysprec_
 
Ptr< Krylov< Real > > krylov_
 
int iterKrylov_
 
int flagKrylov_
 
Ptr< Vector< Real > > v1_
 
Ptr< Vector< Real > > v2_
 
Ptr< PartitionedVector< Real > > vv_
 
Ptr< Vector< Real > > b1_
 
Ptr< Vector< Real > > b2_
 
Ptr< PartitionedVector< Real > > bb_
 
Ptr< Vector< Real > > w1_
 
Ptr< Vector< Real > > w2_
 
Ptr< PartitionedVector< Real > > ww_
 
Ptr< Vector< Real > > mul_
 
int dim_
 
Real b1sqr_
 

Detailed Description

template<class Real>
class ROL::NullSpaceOperator< Real >

Projects on to the null space of a linear constraint.


Definition at line 63 of file ROL_NullSpaceOperator.hpp.

Constructor & Destructor Documentation

template<class Real >
virtual ROL::NullSpaceOperator< Real >::~NullSpaceOperator ( )
inlinevirtual

Definition at line 117 of file ROL_NullSpaceOperator.hpp.

template<class Real >
ROL::NullSpaceOperator< Real >::NullSpaceOperator ( const Ptr< Constraint< Real >> &  con,
const Ptr< Vector< Real >> &  dom,
const Ptr< Vector< Real >> &  ran 
)
inline

Member Function Documentation

template<class Real >
void ROL::NullSpaceOperator< Real >::solveAugmentedSystem ( Vector< Real > &  v,
Vector< Real > &  b,
Real &  tol,
bool  refine = false 
) const
inlineprivate
template<class Real >
virtual void ROL::NullSpaceOperator< 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 161 of file ROL_NullSpaceOperator.hpp.

References ROL::Vector< Real >::axpy(), ROL::NullSpaceOperator< Real >::b1_, ROL::NullSpaceOperator< Real >::b1sqr_, ROL::NullSpaceOperator< Real >::b2_, ROL::NullSpaceOperator< Real >::bb_, ROL::NullSpaceOperator< Real >::dim_, ROL::Vector< Real >::dot(), ROL::NullSpaceOperator< Real >::mul_, ROL::Vector< Real >::set(), and ROL::NullSpaceOperator< Real >::solveAugmentedSystem().

Referenced by ROL::NullSpaceOperator< Real >::applyAdjoint().

template<class Real >
void ROL::NullSpaceOperator< Real >::applyAdjoint ( Vector< Real > &  Hv,
const Vector< Real > &  v,
Real &  tol 
) const
inlinevirtual

Apply adjoint of linear operator.

This function applies the adjoint of a linear operator to a vector. Default behavior assumes operator is self-adjoint.

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 174 of file ROL_NullSpaceOperator.hpp.

References ROL::NullSpaceOperator< Real >::apply().

template<class Real >
void ROL::NullSpaceOperator< 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 178 of file ROL_NullSpaceOperator.hpp.

template<class Real >
void ROL::NullSpaceOperator< Real >::applyAdjointInverse ( Vector< Real > &  Hv,
const Vector< Real > &  v,
Real &  tol 
) const
inlinevirtual

Apply adjoint of the inverse linear operator.

This function applies the adjoint of the inverse linear operator to a vector. Default behavior assumes operator is self-adjoint.

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 182 of file ROL_NullSpaceOperator.hpp.

Member Data Documentation

template<class Real >
const Ptr<Constraint<Real> > ROL::NullSpaceOperator< Real >::con_
private
template<class Real >
const bool ROL::NullSpaceOperator< Real >::useInexact_
private
template<class Real >
Ptr<LinearOperator<Real> > ROL::NullSpaceOperator< Real >::augsys_
private
template<class Real >
Ptr<LinearOperator<Real> > ROL::NullSpaceOperator< Real >::augsysprec_
private
template<class Real >
Ptr<Krylov<Real> > ROL::NullSpaceOperator< Real >::krylov_
private
template<class Real >
int ROL::NullSpaceOperator< Real >::iterKrylov_
mutableprivate
template<class Real >
int ROL::NullSpaceOperator< Real >::flagKrylov_
mutableprivate
template<class Real >
Ptr<Vector<Real> > ROL::NullSpaceOperator< Real >::v1_
mutableprivate
template<class Real >
Ptr<Vector<Real> > ROL::NullSpaceOperator< Real >::v2_
mutableprivate
template<class Real >
Ptr<PartitionedVector<Real> > ROL::NullSpaceOperator< Real >::vv_
mutableprivate
template<class Real >
Ptr<Vector<Real> > ROL::NullSpaceOperator< Real >::b1_
mutableprivate
template<class Real >
Ptr<Vector<Real> > ROL::NullSpaceOperator< Real >::b2_
mutableprivate
template<class Real >
Ptr<PartitionedVector<Real> > ROL::NullSpaceOperator< Real >::bb_
mutableprivate
template<class Real >
Ptr<Vector<Real> > ROL::NullSpaceOperator< Real >::w1_
mutableprivate
template<class Real >
Ptr<Vector<Real> > ROL::NullSpaceOperator< Real >::w2_
mutableprivate
template<class Real >
Ptr<PartitionedVector<Real> > ROL::NullSpaceOperator< Real >::ww_
mutableprivate
template<class Real >
Ptr<Vector<Real> > ROL::NullSpaceOperator< Real >::mul_
mutableprivate
template<class Real >
int ROL::NullSpaceOperator< Real >::dim_
private
template<class Real >
Real ROL::NullSpaceOperator< Real >::b1sqr_
private

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