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

#include <example_04.hpp>

+ Inheritance diagram for H1BoundConstraint< Real >:

Public Member Functions

 H1BoundConstraint (std::vector< Real > &l, std::vector< Real > &u, const Teuchos::RCP< BurgersFEM< Real > > &fem, Real scale=1.0)
 
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 pruneActive (ROL::Vector< Real > &v, const ROL::Vector< Real > &x, Real eps)
 Set variables to zero if they correspond to the \(\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 pruneActive (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 \(\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...
 
 H1BoundConstraint (std::vector< Real > &l, std::vector< Real > &u, const Teuchos::RCP< BurgersFEM< Real > > &fem, Real scale=1.0)
 
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 pruneActive (ROL::Vector< Real > &v, const ROL::Vector< Real > &x, Real eps)
 Set variables to zero if they correspond to the \(\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 pruneActive (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 \(\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...
 
 H1BoundConstraint (std::vector< Real > &l, std::vector< Real > &u, const Teuchos::RCP< BurgersFEM< Real > > &fem, Real scale=1.0)
 
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 pruneActive (ROL::Vector< Real > &v, const ROL::Vector< Real > &x, Real eps)
 Set variables to zero if they correspond to the \(\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 pruneActive (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 \(\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...
 
 H1BoundConstraint (std::vector< Real > &l, std::vector< Real > &u, const Teuchos::RCP< BurgersFEM< Real > > &fem, Real scale=1.0)
 
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 pruneActive (ROL::Vector< Real > &v, const ROL::Vector< Real > &x, Real eps)
 Set variables to zero if they correspond to the \(\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 pruneActive (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 \(\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)
 
 BoundConstraint (const Vector< Real > &x)
 
 BoundConstraint (const Teuchos::RCP< Vector< Real > > &x_lo, const Teuchos::RCP< Vector< Real > > &x_up, const Real scale=1)
 Default constructor. More...
 
virtual void update (const Vector< Real > &x, bool flag=true, int iter=-1)
 Update bounds. More...
 
virtual const Teuchos::RCP< const Vector< Real > > getLowerVectorRCP (void) const
 Return the ref count pointer to the lower bound vector. More...
 
virtual const Teuchos::RCP< const Vector< Real > > getUpperVectorRCP (void) const
 Return the ref count pointer to the upper bound vector. More...
 
virtual const Teuchos::RCP< Vector< Real > > getLowerVectorRCP (void)
 Return the ref count pointer to the lower bound vector. More...
 
virtual const Teuchos::RCP< Vector< Real > > getUpperVectorRCP (void)
 Return the ref count pointer to the upper bound vector. 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)
 Set variables to zero if they correspond to the \(\epsilon\)-inactive set. More...
 
void pruneLowerInactive (Vector< Real > &v, const Vector< Real > &x, Real eps=0)
 
void pruneUpperInactive (Vector< Real > &v, const Vector< Real > &x, Real eps=0)
 
void pruneInactive (Vector< Real > &v, const Vector< Real > &g, const Vector< Real > &x, Real eps=0)
 Set variables to zero if they correspond to the \(\epsilon\)-nonbinding set. More...
 
void pruneLowerInactive (Vector< Real > &v, const Vector< Real > &g, const Vector< Real > &x, Real eps=0)
 
void pruneUpperInactive (Vector< Real > &v, const Vector< Real > &g, const Vector< Real > &x, Real eps=0)
 
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 Member Functions

void cast_vector (Teuchos::RCP< std::vector< Real > > &xvec, ROL::Vector< Real > &x) const
 
void cast_const_vector (Teuchos::RCP< const std::vector< Real > > &xvec, const ROL::Vector< Real > &x) const
 
void axpy (std::vector< Real > &out, const Real a, const std::vector< Real > &x, const std::vector< Real > &y) const
 
void projection (std::vector< Real > &x)
 
void cast_vector (Teuchos::RCP< std::vector< Real > > &xvec, ROL::Vector< Real > &x) const
 
void cast_const_vector (Teuchos::RCP< const std::vector< Real > > &xvec, const ROL::Vector< Real > &x) const
 
void axpy (std::vector< Real > &out, const Real a, const std::vector< Real > &x, const std::vector< Real > &y) const
 
void projection (std::vector< Real > &x)
 
void cast_vector (Teuchos::RCP< std::vector< Real > > &xvec, ROL::Vector< Real > &x) const
 
void cast_const_vector (Teuchos::RCP< const std::vector< Real > > &xvec, const ROL::Vector< Real > &x) const
 
void axpy (std::vector< Real > &out, const Real a, const std::vector< Real > &x, const std::vector< Real > &y) const
 
void projection (std::vector< Real > &x)
 
void cast_vector (Teuchos::RCP< std::vector< Real > > &xvec, ROL::Vector< Real > &x) const
 
void cast_const_vector (Teuchos::RCP< const std::vector< Real > > &xvec, const ROL::Vector< Real > &x) const
 
void axpy (std::vector< Real > &out, const Real a, const std::vector< Real > &x, const std::vector< Real > &y) const
 
void projection (std::vector< Real > &x)
 

Private Attributes

int dim_
 
std::vector< Real > x_lo_
 
std::vector< Real > x_up_
 
Real min_diff_
 
Real scale_
 
Teuchos::RCP< BurgersFEM< Real > > fem_
 

Detailed Description

template<class Real>
class H1BoundConstraint< Real >

Definition at line 1316 of file example_04.hpp.

Constructor & Destructor Documentation

◆ H1BoundConstraint() [1/4]

template<class Real >
H1BoundConstraint< Real >::H1BoundConstraint ( std::vector< Real > &  l,
std::vector< Real > &  u,
const Teuchos::RCP< BurgersFEM< Real > > &  fem,
Real  scale = 1.0 
)
inline

◆ H1BoundConstraint() [2/4]

template<class Real >
H1BoundConstraint< Real >::H1BoundConstraint ( std::vector< Real > &  l,
std::vector< Real > &  u,
const Teuchos::RCP< BurgersFEM< Real > > &  fem,
Real  scale = 1.0 
)
inline

◆ H1BoundConstraint() [3/4]

template<class Real >
H1BoundConstraint< Real >::H1BoundConstraint ( std::vector< Real > &  l,
std::vector< Real > &  u,
const Teuchos::RCP< BurgersFEM< Real > > &  fem,
Real  scale = 1.0 
)
inline

◆ H1BoundConstraint() [4/4]

template<class Real >
H1BoundConstraint< Real >::H1BoundConstraint ( std::vector< Real > &  l,
std::vector< Real > &  u,
const Teuchos::RCP< BurgersFEM< Real > > &  fem,
Real  scale = 1.0 
)
inline

Member Function Documentation

◆ cast_vector() [1/4]

template<class Real >
void H1BoundConstraint< Real >::cast_vector ( Teuchos::RCP< std::vector< Real > > &  xvec,
ROL::Vector< Real > &  x 
) const
inlineprivate

◆ cast_const_vector() [1/4]

template<class Real >
void H1BoundConstraint< Real >::cast_const_vector ( Teuchos::RCP< const std::vector< Real > > &  xvec,
const ROL::Vector< Real > &  x 
) const
inlineprivate

◆ axpy() [1/4]

template<class Real >
void H1BoundConstraint< Real >::axpy ( std::vector< Real > &  out,
const Real  a,
const std::vector< Real > &  x,
const std::vector< Real > &  y 
) const
inlineprivate

Definition at line 1349 of file example_04.hpp.

References H1BoundConstraint< Real >::dim_.

◆ projection() [1/4]

template<class Real >
void H1BoundConstraint< Real >::projection ( std::vector< Real > &  x)
inlineprivate

◆ isFeasible() [1/4]

template<class Real >
bool H1BoundConstraint< 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 1379 of file example_04.hpp.

References H1BoundConstraint< Real >::cast_const_vector(), H1BoundConstraint< Real >::dim_, H1BoundConstraint< Real >::x_lo_, and H1BoundConstraint< Real >::x_up_.

◆ project() [1/4]

template<class Real >
void H1BoundConstraint< 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 1391 of file example_04.hpp.

References H1BoundConstraint< Real >::cast_vector(), and H1BoundConstraint< Real >::projection().

◆ pruneLowerActive() [1/8]

template<class Real >
void H1BoundConstraint< 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 1396 of file example_04.hpp.

References H1BoundConstraint< Real >::cast_const_vector(), H1BoundConstraint< Real >::cast_vector(), H1BoundConstraint< Real >::dim_, H1BoundConstraint< Real >::min_diff_, H1BoundConstraint< Real >::scale_, and H1BoundConstraint< Real >::x_lo_.

◆ pruneUpperActive() [1/8]

template<class Real >
void H1BoundConstraint< 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 1407 of file example_04.hpp.

References H1BoundConstraint< Real >::cast_const_vector(), H1BoundConstraint< Real >::cast_vector(), H1BoundConstraint< Real >::dim_, H1BoundConstraint< Real >::min_diff_, H1BoundConstraint< Real >::scale_, and H1BoundConstraint< Real >::x_up_.

◆ pruneActive() [1/8]

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

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

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

\[ \mathcal{A}_\epsilon(x) = \mathcal{A}^+_\epsilon(x)\cap\mathcal{A}^-_\epsilon(x). \]

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 1418 of file example_04.hpp.

References H1BoundConstraint< Real >::cast_const_vector(), H1BoundConstraint< Real >::cast_vector(), H1BoundConstraint< Real >::dim_, H1BoundConstraint< Real >::min_diff_, H1BoundConstraint< Real >::scale_, H1BoundConstraint< Real >::x_lo_, and H1BoundConstraint< Real >::x_up_.

◆ pruneLowerActive() [2/8]

template<class Real >
void H1BoundConstraint< 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]gis the negative search direction.
[in]xis the current optimization variable.
[in]epsis the active-set tolerance \(\epsilon\).

Reimplemented from ROL::BoundConstraint< Real >.

Definition at line 1430 of file example_04.hpp.

References H1BoundConstraint< Real >::cast_const_vector(), H1BoundConstraint< Real >::cast_vector(), H1BoundConstraint< Real >::dim_, H1BoundConstraint< Real >::min_diff_, H1BoundConstraint< Real >::scale_, and H1BoundConstraint< Real >::x_lo_.

◆ pruneUpperActive() [2/8]

template<class Real >
void H1BoundConstraint< 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]gis the negative search direction.
[in]xis the current optimization variable.
[in]epsis the active-set tolerance \(\epsilon\).

Reimplemented from ROL::BoundConstraint< Real >.

Definition at line 1442 of file example_04.hpp.

References H1BoundConstraint< Real >::cast_const_vector(), H1BoundConstraint< Real >::cast_vector(), H1BoundConstraint< Real >::dim_, H1BoundConstraint< Real >::min_diff_, H1BoundConstraint< Real >::scale_, and H1BoundConstraint< Real >::x_up_.

◆ pruneActive() [2/8]

template<class Real >
void H1BoundConstraint< Real >::pruneActive ( 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 \(\epsilon\)-binding set.

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

\[ \mathcal{B}^+_\epsilon(x) = \mathcal{B}^+_\epsilon(x)\cap\mathcal{B}^-_\epsilon(x). \]

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

Reimplemented from ROL::BoundConstraint< Real >.

Definition at line 1454 of file example_04.hpp.

References H1BoundConstraint< Real >::cast_const_vector(), H1BoundConstraint< Real >::cast_vector(), H1BoundConstraint< Real >::dim_, H1BoundConstraint< Real >::min_diff_, H1BoundConstraint< Real >::scale_, H1BoundConstraint< Real >::x_lo_, and H1BoundConstraint< Real >::x_up_.

◆ setVectorToUpperBound() [1/4]

template<class Real >
void H1BoundConstraint< 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 1467 of file example_04.hpp.

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

◆ setVectorToLowerBound() [1/4]

template<class Real >
void H1BoundConstraint< 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 1474 of file example_04.hpp.

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

◆ cast_vector() [2/4]

template<class Real >
void H1BoundConstraint< Real >::cast_vector ( Teuchos::RCP< std::vector< Real > > &  xvec,
ROL::Vector< Real > &  x 
) const
inlineprivate

Definition at line 1384 of file example_06.hpp.

◆ cast_const_vector() [2/4]

template<class Real >
void H1BoundConstraint< Real >::cast_const_vector ( Teuchos::RCP< const std::vector< Real > > &  xvec,
const ROL::Vector< Real > &  x 
) const
inlineprivate

Definition at line 1396 of file example_06.hpp.

◆ axpy() [2/4]

template<class Real >
void H1BoundConstraint< Real >::axpy ( std::vector< Real > &  out,
const Real  a,
const std::vector< Real > &  x,
const std::vector< Real > &  y 
) const
inlineprivate

Definition at line 1408 of file example_06.hpp.

References H1BoundConstraint< Real >::dim_.

◆ projection() [2/4]

template<class Real >
void H1BoundConstraint< Real >::projection ( std::vector< Real > &  x)
inlineprivate

◆ isFeasible() [2/4]

template<class Real >
bool H1BoundConstraint< 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 1438 of file example_06.hpp.

References H1BoundConstraint< Real >::cast_const_vector(), H1BoundConstraint< Real >::dim_, H1BoundConstraint< Real >::x_lo_, and H1BoundConstraint< Real >::x_up_.

◆ project() [2/4]

template<class Real >
void H1BoundConstraint< 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 1450 of file example_06.hpp.

References H1BoundConstraint< Real >::cast_vector(), and H1BoundConstraint< Real >::projection().

◆ pruneLowerActive() [3/8]

template<class Real >
void H1BoundConstraint< 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 1455 of file example_06.hpp.

References H1BoundConstraint< Real >::cast_const_vector(), H1BoundConstraint< Real >::cast_vector(), H1BoundConstraint< Real >::dim_, H1BoundConstraint< Real >::min_diff_, H1BoundConstraint< Real >::scale_, and H1BoundConstraint< Real >::x_lo_.

◆ pruneUpperActive() [3/8]

template<class Real >
void H1BoundConstraint< 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 1466 of file example_06.hpp.

References H1BoundConstraint< Real >::cast_const_vector(), H1BoundConstraint< Real >::cast_vector(), H1BoundConstraint< Real >::dim_, H1BoundConstraint< Real >::min_diff_, H1BoundConstraint< Real >::scale_, and H1BoundConstraint< Real >::x_up_.

◆ pruneActive() [3/8]

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

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

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

\[ \mathcal{A}_\epsilon(x) = \mathcal{A}^+_\epsilon(x)\cap\mathcal{A}^-_\epsilon(x). \]

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 1477 of file example_06.hpp.

References H1BoundConstraint< Real >::cast_const_vector(), H1BoundConstraint< Real >::cast_vector(), H1BoundConstraint< Real >::dim_, H1BoundConstraint< Real >::min_diff_, H1BoundConstraint< Real >::scale_, H1BoundConstraint< Real >::x_lo_, and H1BoundConstraint< Real >::x_up_.

◆ pruneLowerActive() [4/8]

template<class Real >
void H1BoundConstraint< 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]gis the negative search direction.
[in]xis the current optimization variable.
[in]epsis the active-set tolerance \(\epsilon\).

Reimplemented from ROL::BoundConstraint< Real >.

Definition at line 1489 of file example_06.hpp.

References H1BoundConstraint< Real >::cast_const_vector(), H1BoundConstraint< Real >::cast_vector(), H1BoundConstraint< Real >::dim_, H1BoundConstraint< Real >::min_diff_, H1BoundConstraint< Real >::scale_, and H1BoundConstraint< Real >::x_lo_.

◆ pruneUpperActive() [4/8]

template<class Real >
void H1BoundConstraint< 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]gis the negative search direction.
[in]xis the current optimization variable.
[in]epsis the active-set tolerance \(\epsilon\).

Reimplemented from ROL::BoundConstraint< Real >.

Definition at line 1501 of file example_06.hpp.

References H1BoundConstraint< Real >::cast_const_vector(), H1BoundConstraint< Real >::cast_vector(), H1BoundConstraint< Real >::dim_, H1BoundConstraint< Real >::min_diff_, H1BoundConstraint< Real >::scale_, and H1BoundConstraint< Real >::x_up_.

◆ pruneActive() [4/8]

template<class Real >
void H1BoundConstraint< Real >::pruneActive ( 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 \(\epsilon\)-binding set.

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

\[ \mathcal{B}^+_\epsilon(x) = \mathcal{B}^+_\epsilon(x)\cap\mathcal{B}^-_\epsilon(x). \]

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

Reimplemented from ROL::BoundConstraint< Real >.

Definition at line 1513 of file example_06.hpp.

References H1BoundConstraint< Real >::cast_const_vector(), H1BoundConstraint< Real >::cast_vector(), H1BoundConstraint< Real >::dim_, H1BoundConstraint< Real >::min_diff_, H1BoundConstraint< Real >::scale_, H1BoundConstraint< Real >::x_lo_, and H1BoundConstraint< Real >::x_up_.

◆ setVectorToUpperBound() [2/4]

template<class Real >
void H1BoundConstraint< 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 1526 of file example_06.hpp.

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

◆ setVectorToLowerBound() [2/4]

template<class Real >
void H1BoundConstraint< 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 1533 of file example_06.hpp.

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

◆ cast_vector() [3/4]

template<class Real >
void H1BoundConstraint< Real >::cast_vector ( Teuchos::RCP< std::vector< Real > > &  xvec,
ROL::Vector< Real > &  x 
) const
inlineprivate

Definition at line 1400 of file example_07.hpp.

◆ cast_const_vector() [3/4]

template<class Real >
void H1BoundConstraint< Real >::cast_const_vector ( Teuchos::RCP< const std::vector< Real > > &  xvec,
const ROL::Vector< Real > &  x 
) const
inlineprivate

Definition at line 1412 of file example_07.hpp.

◆ axpy() [3/4]

template<class Real >
void H1BoundConstraint< Real >::axpy ( std::vector< Real > &  out,
const Real  a,
const std::vector< Real > &  x,
const std::vector< Real > &  y 
) const
inlineprivate

Definition at line 1424 of file example_07.hpp.

References H1BoundConstraint< Real >::dim_.

◆ projection() [3/4]

template<class Real >
void H1BoundConstraint< Real >::projection ( std::vector< Real > &  x)
inlineprivate

◆ isFeasible() [3/4]

template<class Real >
bool H1BoundConstraint< 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 1454 of file example_07.hpp.

References H1BoundConstraint< Real >::cast_const_vector(), H1BoundConstraint< Real >::dim_, H1BoundConstraint< Real >::x_lo_, and H1BoundConstraint< Real >::x_up_.

◆ project() [3/4]

template<class Real >
void H1BoundConstraint< 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 1466 of file example_07.hpp.

References H1BoundConstraint< Real >::cast_vector(), and H1BoundConstraint< Real >::projection().

◆ pruneLowerActive() [5/8]

template<class Real >
void H1BoundConstraint< 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 1471 of file example_07.hpp.

References H1BoundConstraint< Real >::cast_const_vector(), H1BoundConstraint< Real >::cast_vector(), H1BoundConstraint< Real >::dim_, H1BoundConstraint< Real >::min_diff_, H1BoundConstraint< Real >::scale_, and H1BoundConstraint< Real >::x_lo_.

◆ pruneUpperActive() [5/8]

template<class Real >
void H1BoundConstraint< 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 1482 of file example_07.hpp.

References H1BoundConstraint< Real >::cast_const_vector(), H1BoundConstraint< Real >::cast_vector(), H1BoundConstraint< Real >::dim_, H1BoundConstraint< Real >::min_diff_, H1BoundConstraint< Real >::scale_, and H1BoundConstraint< Real >::x_up_.

◆ pruneActive() [5/8]

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

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

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

\[ \mathcal{A}_\epsilon(x) = \mathcal{A}^+_\epsilon(x)\cap\mathcal{A}^-_\epsilon(x). \]

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 1493 of file example_07.hpp.

References H1BoundConstraint< Real >::cast_const_vector(), H1BoundConstraint< Real >::cast_vector(), H1BoundConstraint< Real >::dim_, H1BoundConstraint< Real >::min_diff_, H1BoundConstraint< Real >::scale_, H1BoundConstraint< Real >::x_lo_, and H1BoundConstraint< Real >::x_up_.

◆ pruneLowerActive() [6/8]

template<class Real >
void H1BoundConstraint< 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]gis the negative search direction.
[in]xis the current optimization variable.
[in]epsis the active-set tolerance \(\epsilon\).

Reimplemented from ROL::BoundConstraint< Real >.

Definition at line 1505 of file example_07.hpp.

References H1BoundConstraint< Real >::cast_const_vector(), H1BoundConstraint< Real >::cast_vector(), H1BoundConstraint< Real >::dim_, H1BoundConstraint< Real >::min_diff_, H1BoundConstraint< Real >::scale_, and H1BoundConstraint< Real >::x_lo_.

◆ pruneUpperActive() [6/8]

template<class Real >
void H1BoundConstraint< 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]gis the negative search direction.
[in]xis the current optimization variable.
[in]epsis the active-set tolerance \(\epsilon\).

Reimplemented from ROL::BoundConstraint< Real >.

Definition at line 1517 of file example_07.hpp.

References H1BoundConstraint< Real >::cast_const_vector(), H1BoundConstraint< Real >::cast_vector(), H1BoundConstraint< Real >::dim_, H1BoundConstraint< Real >::min_diff_, H1BoundConstraint< Real >::scale_, and H1BoundConstraint< Real >::x_up_.

◆ pruneActive() [6/8]

template<class Real >
void H1BoundConstraint< Real >::pruneActive ( 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 \(\epsilon\)-binding set.

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

\[ \mathcal{B}^+_\epsilon(x) = \mathcal{B}^+_\epsilon(x)\cap\mathcal{B}^-_\epsilon(x). \]

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

Reimplemented from ROL::BoundConstraint< Real >.

Definition at line 1529 of file example_07.hpp.

References H1BoundConstraint< Real >::cast_const_vector(), H1BoundConstraint< Real >::cast_vector(), H1BoundConstraint< Real >::dim_, H1BoundConstraint< Real >::min_diff_, H1BoundConstraint< Real >::scale_, H1BoundConstraint< Real >::x_lo_, and H1BoundConstraint< Real >::x_up_.

◆ setVectorToUpperBound() [3/4]

template<class Real >
void H1BoundConstraint< 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 1542 of file example_07.hpp.

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

◆ setVectorToLowerBound() [3/4]

template<class Real >
void H1BoundConstraint< 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 1549 of file example_07.hpp.

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

◆ cast_vector() [4/4]

template<class Real >
void H1BoundConstraint< Real >::cast_vector ( Teuchos::RCP< std::vector< Real > > &  xvec,
ROL::Vector< Real > &  x 
) const
inlineprivate

Definition at line 1384 of file example_08.hpp.

◆ cast_const_vector() [4/4]

template<class Real >
void H1BoundConstraint< Real >::cast_const_vector ( Teuchos::RCP< const std::vector< Real > > &  xvec,
const ROL::Vector< Real > &  x 
) const
inlineprivate

Definition at line 1396 of file example_08.hpp.

◆ axpy() [4/4]

template<class Real >
void H1BoundConstraint< Real >::axpy ( std::vector< Real > &  out,
const Real  a,
const std::vector< Real > &  x,
const std::vector< Real > &  y 
) const
inlineprivate

Definition at line 1408 of file example_08.hpp.

References H1BoundConstraint< Real >::dim_.

◆ projection() [4/4]

template<class Real >
void H1BoundConstraint< Real >::projection ( std::vector< Real > &  x)
inlineprivate

◆ isFeasible() [4/4]

template<class Real >
bool H1BoundConstraint< 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 1438 of file example_08.hpp.

References H1BoundConstraint< Real >::cast_const_vector(), H1BoundConstraint< Real >::dim_, H1BoundConstraint< Real >::x_lo_, and H1BoundConstraint< Real >::x_up_.

◆ project() [4/4]

template<class Real >
void H1BoundConstraint< 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 1450 of file example_08.hpp.

References H1BoundConstraint< Real >::cast_vector(), and H1BoundConstraint< Real >::projection().

◆ pruneLowerActive() [7/8]

template<class Real >
void H1BoundConstraint< 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 1455 of file example_08.hpp.

References H1BoundConstraint< Real >::cast_const_vector(), H1BoundConstraint< Real >::cast_vector(), H1BoundConstraint< Real >::dim_, H1BoundConstraint< Real >::min_diff_, H1BoundConstraint< Real >::scale_, and H1BoundConstraint< Real >::x_lo_.

◆ pruneUpperActive() [7/8]

template<class Real >
void H1BoundConstraint< 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 1466 of file example_08.hpp.

References H1BoundConstraint< Real >::cast_const_vector(), H1BoundConstraint< Real >::cast_vector(), H1BoundConstraint< Real >::dim_, H1BoundConstraint< Real >::min_diff_, H1BoundConstraint< Real >::scale_, and H1BoundConstraint< Real >::x_up_.

◆ pruneActive() [7/8]

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

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

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

\[ \mathcal{A}_\epsilon(x) = \mathcal{A}^+_\epsilon(x)\cap\mathcal{A}^-_\epsilon(x). \]

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 1477 of file example_08.hpp.

References H1BoundConstraint< Real >::cast_const_vector(), H1BoundConstraint< Real >::cast_vector(), H1BoundConstraint< Real >::dim_, H1BoundConstraint< Real >::min_diff_, H1BoundConstraint< Real >::scale_, H1BoundConstraint< Real >::x_lo_, and H1BoundConstraint< Real >::x_up_.

◆ pruneLowerActive() [8/8]

template<class Real >
void H1BoundConstraint< 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]gis the negative search direction.
[in]xis the current optimization variable.
[in]epsis the active-set tolerance \(\epsilon\).

Reimplemented from ROL::BoundConstraint< Real >.

Definition at line 1489 of file example_08.hpp.

References H1BoundConstraint< Real >::cast_const_vector(), H1BoundConstraint< Real >::cast_vector(), H1BoundConstraint< Real >::dim_, H1BoundConstraint< Real >::min_diff_, H1BoundConstraint< Real >::scale_, and H1BoundConstraint< Real >::x_lo_.

◆ pruneUpperActive() [8/8]

template<class Real >
void H1BoundConstraint< 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]gis the negative search direction.
[in]xis the current optimization variable.
[in]epsis the active-set tolerance \(\epsilon\).

Reimplemented from ROL::BoundConstraint< Real >.

Definition at line 1501 of file example_08.hpp.

References H1BoundConstraint< Real >::cast_const_vector(), H1BoundConstraint< Real >::cast_vector(), H1BoundConstraint< Real >::dim_, H1BoundConstraint< Real >::min_diff_, H1BoundConstraint< Real >::scale_, and H1BoundConstraint< Real >::x_up_.

◆ pruneActive() [8/8]

template<class Real >
void H1BoundConstraint< Real >::pruneActive ( 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 \(\epsilon\)-binding set.

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

\[ \mathcal{B}^+_\epsilon(x) = \mathcal{B}^+_\epsilon(x)\cap\mathcal{B}^-_\epsilon(x). \]

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

Reimplemented from ROL::BoundConstraint< Real >.

Definition at line 1513 of file example_08.hpp.

References H1BoundConstraint< Real >::cast_const_vector(), H1BoundConstraint< Real >::cast_vector(), H1BoundConstraint< Real >::dim_, H1BoundConstraint< Real >::min_diff_, H1BoundConstraint< Real >::scale_, H1BoundConstraint< Real >::x_lo_, and H1BoundConstraint< Real >::x_up_.

◆ setVectorToUpperBound() [4/4]

template<class Real >
void H1BoundConstraint< 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 1526 of file example_08.hpp.

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

◆ setVectorToLowerBound() [4/4]

template<class Real >
void H1BoundConstraint< 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 1533 of file example_08.hpp.

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

Member Data Documentation

◆ dim_

template<class Real >
int H1BoundConstraint< Real >::dim_
private

◆ x_lo_

template<class Real >
std::vector< Real > H1BoundConstraint< Real >::x_lo_
private

◆ x_up_

template<class Real >
std::vector< Real > H1BoundConstraint< Real >::x_up_
private

◆ min_diff_

template<class Real >
Real H1BoundConstraint< Real >::min_diff_
private

◆ scale_

template<class Real >
Real H1BoundConstraint< Real >::scale_
private

◆ fem_

template<class Real >
Teuchos::RCP< BurgersFEM< Real > > H1BoundConstraint< Real >::fem_
private

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