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

Public Member Functions

 BoundConstraint_PoissonControl (std::vector< Real > &lo, std::vector< Real > &up)
 
bool isFeasible (const ROL::Vector< Real > &x)
 Check if the vector, v, is feasible. More...
 
void project (ROL::Vector< Real > &x)
 Project optimization variables onto the bounds. More...
 
void pruneLowerActive (ROL::Vector< Real > &v, const ROL::Vector< Real > &x, Real eps)
 Set variables to zero if they correspond to the lower \(\epsilon\)-active set. More...
 
void pruneUpperActive (ROL::Vector< Real > &v, const ROL::Vector< Real > &x, Real eps)
 Set variables to zero if they correspond to the upper \(\epsilon\)-active set. More...
 
void pruneLowerActive (ROL::Vector< Real > &v, const ROL::Vector< Real > &g, const ROL::Vector< Real > &x, Real eps)
 Set variables to zero if they correspond to the lower \(\epsilon\)-binding set. More...
 
void pruneUpperActive (ROL::Vector< Real > &v, const ROL::Vector< Real > &g, const ROL::Vector< Real > &x, Real eps)
 Set variables to zero if they correspond to the upper \(\epsilon\)-binding set. More...
 
void setVectorToUpperBound (ROL::Vector< Real > &u)
 Set the input vector to the upper bound. More...
 
void setVectorToLowerBound (ROL::Vector< Real > &l)
 Set the input vector to the lower bound. More...
 
- Public Member Functions inherited from ROL::BoundConstraint< Real >
virtual ~BoundConstraint ()
 
 BoundConstraint (void)
 Default constructor. More...
 
virtual void update (const Vector< Real > &x, bool flag=true, int iter=-1)
 Update bounds. More...
 
virtual void pruneActive (Vector< Real > &v, const Vector< Real > &x, Real eps=0.0)
 Set variables to zero if they correspond to the \(\epsilon\)-active set. More...
 
virtual void pruneActive (Vector< Real > &v, const Vector< Real > &g, const Vector< Real > &x, Real eps=0.0)
 Set variables to zero if they correspond to the \(\epsilon\)-binding set. More...
 
void activate (void)
 Turn on bounds. More...
 
void deactivate (void)
 Turn off bounds. More...
 
bool isActivated (void)
 Check if bounds are on. More...
 
void pruneInactive (Vector< Real > &v, const Vector< Real > &x, Real eps=0.0)
 Set variables to zero if they correspond to the \(\epsilon\)-inactive set. More...
 
void pruneInactive (Vector< Real > &v, const Vector< Real > &g, const Vector< Real > &x, Real eps=0.0)
 Set variables to zero if they correspond to the \(\epsilon\)-nonbinding set. More...
 
void computeProjectedGradient (Vector< Real > &g, const Vector< Real > &x)
 Compute projected gradient. More...
 
void computeProjectedStep (Vector< Real > &v, const Vector< Real > &x)
 Compute projected step. More...
 

Private Attributes

int dim_
 
std::vector< Real > x_lo_
 
std::vector< Real > x_up_
 
Real min_diff_
 

Detailed Description

template<class Real>
class BoundConstraint_PoissonControl< Real >

Definition at line 66 of file poisson-control/example_01.cpp.

Constructor & Destructor Documentation

template<class Real>
BoundConstraint_PoissonControl< Real >::BoundConstraint_PoissonControl ( std::vector< Real > &  lo,
std::vector< Real > &  up 
)
inline

Member Function Documentation

template<class Real>
bool BoundConstraint_PoissonControl< Real >::isFeasible ( const ROL::Vector< Real > &  v)
inlinevirtual

Check if the vector, v, is feasible.

This function returns true if \(v = P_{[a,b]}(v)\).

Parameters
[in]vis the vector to be checked.

Reimplemented from ROL::BoundConstraint< Real >.

Definition at line 89 of file poisson-control/example_01.cpp.

References BoundConstraint_PoissonControl< Real >::dim_, BoundConstraint_PoissonControl< Real >::x_lo_, and BoundConstraint_PoissonControl< Real >::x_up_.

template<class Real>
void BoundConstraint_PoissonControl< Real >::project ( ROL::Vector< Real > &  x)
inlinevirtual

Project optimization variables onto the bounds.

This function implements the projection of \(x\) onto the bounds, i.e.,

\[ (P_{[a,b]}(x))(\xi) = \min\{b(\xi),\max\{a(\xi),x(\xi)\}\} \quad \text{for almost every }\xi\in\Xi. \]

Parameters
[in,out]xis the optimization variable.

Reimplemented from ROL::BoundConstraint< Real >.

Definition at line 101 of file poisson-control/example_01.cpp.

References BoundConstraint_PoissonControl< Real >::dim_, BoundConstraint_PoissonControl< Real >::x_lo_, and BoundConstraint_PoissonControl< Real >::x_up_.

template<class Real>
void BoundConstraint_PoissonControl< Real >::pruneLowerActive ( ROL::Vector< Real > &  v,
const ROL::Vector< Real > &  x,
Real  eps 
)
inlinevirtual

Set variables to zero if they correspond to the lower \(\epsilon\)-active set.

This function sets \(v(\xi)=0\) if \(\xi\in\mathcal{A}^-_\epsilon(x)\). Here, the lower \(\epsilon\)-active set is defined as

\[ \mathcal{A}^-_\epsilon(x) = \{\,\xi\in\Xi\,:\,x(\xi) = a(\xi)+\epsilon\,\}. \]

Parameters
[out]vis the variable to be pruned.
[in]xis the current optimization variable.
[in]epsis the active-set tolerance \(\epsilon\).

Reimplemented from ROL::BoundConstraint< Real >.

Definition at line 108 of file poisson-control/example_01.cpp.

References BoundConstraint_PoissonControl< Real >::dim_, BoundConstraint_PoissonControl< Real >::min_diff_, and BoundConstraint_PoissonControl< Real >::x_lo_.

template<class Real>
void BoundConstraint_PoissonControl< Real >::pruneUpperActive ( ROL::Vector< Real > &  v,
const ROL::Vector< Real > &  x,
Real  eps 
)
inlinevirtual

Set variables to zero if they correspond to the upper \(\epsilon\)-active set.

This function sets \(v(\xi)=0\) if \(\xi\in\mathcal{A}^+_\epsilon(x)\). Here, the upper \(\epsilon\)-active set is defined as

\[ \mathcal{A}^+_\epsilon(x) = \{\,\xi\in\Xi\,:\,x(\xi) = b(\xi)-\epsilon\,\}. \]

Parameters
[out]vis the variable to be pruned.
[in]xis the current optimization variable.
[in]epsis the active-set tolerance \(\epsilon\).

Reimplemented from ROL::BoundConstraint< Real >.

Definition at line 120 of file poisson-control/example_01.cpp.

References BoundConstraint_PoissonControl< Real >::dim_, BoundConstraint_PoissonControl< Real >::min_diff_, and BoundConstraint_PoissonControl< Real >::x_up_.

template<class Real>
void BoundConstraint_PoissonControl< Real >::pruneLowerActive ( ROL::Vector< Real > &  v,
const ROL::Vector< Real > &  g,
const ROL::Vector< Real > &  x,
Real  eps 
)
inlinevirtual

Set variables to zero if they correspond to the lower \(\epsilon\)-binding set.

This function sets \(v(\xi)=0\) if \(\xi\in\mathcal{B}^-_\epsilon(x)\). Here, the lower \(\epsilon\)-binding set is defined as

\[ \mathcal{B}^-_\epsilon(x) = \{\,\xi\in\Xi\,:\,x(\xi) = a(\xi)+\epsilon,\; g(\xi) > 0 \,\}. \]

Parameters
[out]vis the variable to be pruned.
[in]xis the current optimization variable.
[in]gis the negative search direction.
[in]epsis the active-set tolerance \(\epsilon\).

Reimplemented from ROL::BoundConstraint< Real >.

Definition at line 132 of file poisson-control/example_01.cpp.

References BoundConstraint_PoissonControl< Real >::dim_, BoundConstraint_PoissonControl< Real >::min_diff_, and BoundConstraint_PoissonControl< Real >::x_lo_.

template<class Real>
void BoundConstraint_PoissonControl< Real >::pruneUpperActive ( ROL::Vector< Real > &  v,
const ROL::Vector< Real > &  g,
const ROL::Vector< Real > &  x,
Real  eps 
)
inlinevirtual

Set variables to zero if they correspond to the upper \(\epsilon\)-binding set.

This function sets \(v(\xi)=0\) if \(\xi\in\mathcal{B}^+_\epsilon(x)\). Here, the upper \(\epsilon\)-binding set is defined as

\[ \mathcal{B}^+_\epsilon(x) = \{\,\xi\in\Xi\,:\,x(\xi) = b(\xi)-\epsilon,\; g(\xi) < 0 \,\}. \]

Parameters
[out]vis the variable to be pruned.
[in]xis the current optimization variable.
[in]gis the negative search direction.
[in]epsis the active-set tolerance \(\epsilon\).

Reimplemented from ROL::BoundConstraint< Real >.

Definition at line 146 of file poisson-control/example_01.cpp.

References BoundConstraint_PoissonControl< Real >::dim_, BoundConstraint_PoissonControl< Real >::min_diff_, and BoundConstraint_PoissonControl< Real >::x_up_.

template<class Real>
void BoundConstraint_PoissonControl< Real >::setVectorToUpperBound ( ROL::Vector< Real > &  u)
inlinevirtual

Set the input vector to the upper bound.

This function sets the input vector \(u\) to the upper bound \(b\).

Parameters
[out]uis the vector to be set to the upper bound.

Reimplemented from ROL::BoundConstraint< Real >.

Definition at line 160 of file poisson-control/example_01.cpp.

References BoundConstraint_PoissonControl< Real >::dim_, ROL::Vector< Real >::set(), and BoundConstraint_PoissonControl< Real >::x_up_.

template<class Real>
void BoundConstraint_PoissonControl< Real >::setVectorToLowerBound ( ROL::Vector< Real > &  l)
inlinevirtual

Set the input vector to the lower bound.

This function sets the input vector \(l\) to the lower bound \(a\).

Parameters
[out]lis the vector to be set to the lower bound.

Reimplemented from ROL::BoundConstraint< Real >.

Definition at line 166 of file poisson-control/example_01.cpp.

References BoundConstraint_PoissonControl< Real >::dim_, ROL::Vector< Real >::set(), and BoundConstraint_PoissonControl< Real >::x_lo_.

Member Data Documentation

template<class Real>
int BoundConstraint_PoissonControl< Real >::dim_
private
template<class Real>
std::vector<Real> BoundConstraint_PoissonControl< Real >::x_lo_
private
template<class Real>
std::vector<Real> BoundConstraint_PoissonControl< Real >::x_up_
private
template<class Real>
Real BoundConstraint_PoissonControl< Real >::min_diff_
private

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