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

#include <ROL_PrimalDualInteriorPointOperator.hpp>

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

Public Member Functions

 PrimalDualInteriorPointBlock11 (ROL::Ptr< OBJ > &obj, ROL::Ptr< CON > &con, const V &x, ROL::Ptr< V > &scratch, Real delta=0)
 
void update (const Vector< Real > &x, bool flag=true, int iter=-1)
 Update linear operator. More...
 
void apply (Vector< Real > &Hv, const Vector< Real > &v, Real &tol) const
 Apply linear operator. More...
 
void applyInverse (Vector< Real > &Hv, const Vector< Real > &v, Real &tol) const
 Apply inverse of linear operator. More...
 
void setInertia (Real delta)
 
- 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. 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 Vector< Real > V
 
typedef PartitionedVector< Real > PV
 
typedef Objective< Real > OBJ
 
typedef Constraint< Real > CON
 

Private Attributes

ROL::Ptr< const Vx_
 
ROL::Ptr< const Vl_
 
ROL::Ptr< Vscratch_
 
Real delta_
 

Static Private Attributes

static const size_type OPT = 0
 
static const size_type EQUAL = 1
 
static const size_type LOWER = 0
 
static const size_type UPPER = 1
 

Detailed Description

template<class Real>
class ROL::PrimalDualInteriorPointBlock11< Real >

Definition at line 55 of file ROL_PrimalDualInteriorPointOperator.hpp.

Member Typedef Documentation

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

Definition at line 57 of file ROL_PrimalDualInteriorPointOperator.hpp.

template<class Real >
typedef PartitionedVector<Real> ROL::PrimalDualInteriorPointBlock11< Real >::PV
private

Definition at line 58 of file ROL_PrimalDualInteriorPointOperator.hpp.

template<class Real >
typedef Objective<Real> ROL::PrimalDualInteriorPointBlock11< Real >::OBJ
private

Definition at line 59 of file ROL_PrimalDualInteriorPointOperator.hpp.

template<class Real >
typedef Constraint<Real> ROL::PrimalDualInteriorPointBlock11< Real >::CON
private

Definition at line 60 of file ROL_PrimalDualInteriorPointOperator.hpp.

Constructor & Destructor Documentation

template<class Real >
ROL::PrimalDualInteriorPointBlock11< Real >::PrimalDualInteriorPointBlock11 ( ROL::Ptr< OBJ > &  obj,
ROL::Ptr< CON > &  con,
const V x,
ROL::Ptr< V > &  scratch,
Real  delta = 0 
)
inline

Member Function Documentation

template<class Real >
void ROL::PrimalDualInteriorPointBlock11< 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 88 of file ROL_PrimalDualInteriorPointOperator.hpp.

References ROL::PrimalDualInteriorPointBlock11< Real >::EQUAL, ROL::PartitionedVector< Real >::get(), ROL::PrimalDualInteriorPointBlock11< Real >::l_, obj_, ROL::PrimalDualInteriorPointBlock11< Real >::OPT, and ROL::PrimalDualInteriorPointBlock11< Real >::x_.

template<class Real >
void ROL::PrimalDualInteriorPointBlock11< 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 99 of file ROL_PrimalDualInteriorPointOperator.hpp.

References ROL::PrimalDualInteriorPointBlock11< Real >::delta_, ROL::PrimalDualInteriorPointBlock11< Real >::EQUAL, ROL::PartitionedVector< Real >::get(), ROL::PrimalDualInteriorPointBlock11< Real >::l_, obj_, ROL::PrimalDualInteriorPointBlock11< Real >::OPT, ROL::PrimalDualInteriorPointBlock11< Real >::scratch_, and ROL::PrimalDualInteriorPointBlock11< Real >::x_.

template<class Real >
void ROL::PrimalDualInteriorPointBlock11< 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 129 of file ROL_PrimalDualInteriorPointOperator.hpp.

template<class Real >
void ROL::PrimalDualInteriorPointBlock11< Real >::setInertia ( Real  delta)
inline

Member Data Documentation

template<class Real >
const size_type ROL::PrimalDualInteriorPointBlock11< Real >::OPT = 0
staticprivate
template<class Real >
const size_type ROL::PrimalDualInteriorPointBlock11< Real >::EQUAL = 1
staticprivate
template<class Real >
const size_type ROL::PrimalDualInteriorPointBlock11< Real >::LOWER = 0
staticprivate

Definition at line 64 of file ROL_PrimalDualInteriorPointOperator.hpp.

template<class Real >
const size_type ROL::PrimalDualInteriorPointBlock11< Real >::UPPER = 1
staticprivate

Definition at line 65 of file ROL_PrimalDualInteriorPointOperator.hpp.

template<class Real >
ROL::Ptr<const V> ROL::PrimalDualInteriorPointBlock11< Real >::x_
private
template<class Real >
ROL::Ptr<const V> ROL::PrimalDualInteriorPointBlock11< Real >::l_
private
template<class Real >
ROL::Ptr<V> ROL::PrimalDualInteriorPointBlock11< Real >::scratch_
private
template<class Real >
Real ROL::PrimalDualInteriorPointBlock11< Real >::delta_
private

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