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

#include <ROL_SemismoothNewtonProjection.hpp>

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

Classes

class  Jacobian
 
class  Precond
 

Public Member Functions

 SemismoothNewtonProjection (const Vector< Real > &xprim, const Vector< Real > &xdual, const Ptr< BoundConstraint< Real > > &bnd, const Ptr< Constraint< Real > > &con, const Vector< Real > &mul, const Vector< Real > &res)
 
 SemismoothNewtonProjection (const Vector< Real > &xprim, const Vector< Real > &xdual, const Ptr< BoundConstraint< Real > > &bnd, const Ptr< Constraint< Real > > &con, const Vector< Real > &mul, const Vector< Real > &res, ParameterList &list)
 
void project (Vector< Real > &x, std::ostream &stream=std::cout) override
 
- Public Member Functions inherited from ROL::PolyhedralProjection< Real >
virtual ~PolyhedralProjection ()
 
 PolyhedralProjection (const Ptr< BoundConstraint< Real > > &bnd)
 
 PolyhedralProjection (const Vector< Real > &xprim, const Vector< Real > &xdual, const Ptr< BoundConstraint< Real > > &bnd, const Ptr< Constraint< Real > > &con, const Vector< Real > &mul, const Vector< Real > &res)
 
const Ptr< Constraint< Real > > getLinearConstraint (void) const
 
const Ptr< BoundConstraint< Real > > getBoundConstraint (void) const
 
const Ptr< Vector< Real > > getMultiplier (void) const
 
const Ptr< Vector< Real > > getResidual (void) const
 

Private Member Functions

Real residual (Vector< Real > &r, const Vector< Real > &y) const
 
void solve_newton_system (Vector< Real > &s, const Vector< Real > &r, const Vector< Real > &y, const Real mu, const Real rho, int &iter, int &flag) const
 
void update_primal (Vector< Real > &y, const Vector< Real > &x, const Vector< Real > &lam) const
 
void project_ssn (Vector< Real > &x, Vector< Real > &lam, Vector< Real > &dlam, std::ostream &stream=std::cout) const
 
Real compute_tolerance () const
 

Private Attributes

int dim_
 
Ptr< Krylov< Real > > krylov_
 
Ptr< Vector< Real > > xnew_
 
Ptr< Vector< Real > > lnew_
 
Ptr< Vector< Real > > dlam_
 
Real DEFAULT_atol_
 
Real DEFAULT_rtol_
 
Real DEFAULT_stol_
 
Real DEFAULT_decr_
 
Real DEFAULT_factor_
 
Real DEFAULT_regscale_
 
Real DEFAULT_errscale_
 
int DEFAULT_maxit_
 
int DEFAULT_lstype_
 
int DEFAULT_verbosity_
 
bool DEFAULT_useproj_
 
Real atol_
 
Real rtol_
 
Real stol_
 
Real decr_
 
Real factor_
 
Real regscale_
 
Real errscale_
 
Real ctol_
 
int maxit_
 
int lstype_
 
int verbosity_
 
bool useproj_
 

Additional Inherited Members

- Protected Attributes inherited from ROL::PolyhedralProjection< Real >
const Ptr< BoundConstraint< Real > > bnd_
 
const Ptr< Constraint< Real > > con_
 
Ptr< Vector< Real > > xprim_
 
Ptr< Vector< Real > > xdual_
 
Ptr< Vector< Real > > mul_
 
Ptr< Vector< Real > > res_
 

Detailed Description

template<typename Real>
class ROL::SemismoothNewtonProjection< Real >

Definition at line 55 of file ROL_SemismoothNewtonProjection.hpp.

Constructor & Destructor Documentation

◆ SemismoothNewtonProjection() [1/2]

template<typename Real >
ROL::SemismoothNewtonProjection< Real >::SemismoothNewtonProjection ( const Vector< Real > & xprim,
const Vector< Real > & xdual,
const Ptr< BoundConstraint< Real > > & bnd,
const Ptr< Constraint< Real > > & con,
const Vector< Real > & mul,
const Vector< Real > & res )

◆ SemismoothNewtonProjection() [2/2]

template<typename Real >
ROL::SemismoothNewtonProjection< Real >::SemismoothNewtonProjection ( const Vector< Real > & xprim,
const Vector< Real > & xdual,
const Ptr< BoundConstraint< Real > > & bnd,
const Ptr< Constraint< Real > > & con,
const Vector< Real > & mul,
const Vector< Real > & res,
ParameterList & list )

Definition at line 97 of file ROL_SemismoothNewtonProjection_Def.hpp.

References ROL::SemismoothNewtonProjection< Real >::atol_, ROL::Vector< Real >::clone(), ROL::SemismoothNewtonProjection< Real >::compute_tolerance(), ROL::SemismoothNewtonProjection< Real >::ctol_, ROL::SemismoothNewtonProjection< Real >::decr_, ROL::SemismoothNewtonProjection< Real >::DEFAULT_atol_, ROL::SemismoothNewtonProjection< Real >::DEFAULT_decr_, ROL::SemismoothNewtonProjection< Real >::DEFAULT_errscale_, ROL::SemismoothNewtonProjection< Real >::DEFAULT_factor_, ROL::SemismoothNewtonProjection< Real >::DEFAULT_lstype_, ROL::SemismoothNewtonProjection< Real >::DEFAULT_maxit_, ROL::SemismoothNewtonProjection< Real >::DEFAULT_regscale_, ROL::SemismoothNewtonProjection< Real >::DEFAULT_rtol_, ROL::SemismoothNewtonProjection< Real >::DEFAULT_stol_, ROL::SemismoothNewtonProjection< Real >::DEFAULT_useproj_, ROL::SemismoothNewtonProjection< Real >::DEFAULT_verbosity_, ROL::SemismoothNewtonProjection< Real >::dim_, ROL::Vector< Real >::dimension(), ROL::SemismoothNewtonProjection< Real >::dlam_, ROL::SemismoothNewtonProjection< Real >::errscale_, ROL::SemismoothNewtonProjection< Real >::factor_, ROL::SemismoothNewtonProjection< Real >::krylov_, ROL::SemismoothNewtonProjection< Real >::lnew_, ROL::SemismoothNewtonProjection< Real >::lstype_, ROL::SemismoothNewtonProjection< Real >::maxit_, ROL::SemismoothNewtonProjection< Real >::regscale_, ROL::SemismoothNewtonProjection< Real >::rtol_, ROL::SemismoothNewtonProjection< Real >::stol_, ROL::SemismoothNewtonProjection< Real >::useproj_, ROL::SemismoothNewtonProjection< Real >::verbosity_, and ROL::SemismoothNewtonProjection< Real >::xnew_.

Member Function Documentation

◆ project()

template<typename Real >
void ROL::SemismoothNewtonProjection< Real >::project ( Vector< Real > & x,
std::ostream & stream = std::cout )
overridevirtual

Reimplemented from ROL::PolyhedralProjection< Real >.

Definition at line 153 of file ROL_SemismoothNewtonProjection_Def.hpp.

◆ residual()

template<typename Real >
Real ROL::SemismoothNewtonProjection< Real >::residual ( Vector< Real > & r,
const Vector< Real > & y ) const
private

◆ solve_newton_system()

template<typename Real >
void ROL::SemismoothNewtonProjection< Real >::solve_newton_system ( Vector< Real > & s,
const Vector< Real > & r,
const Vector< Real > & y,
const Real mu,
const Real rho,
int & iter,
int & flag ) const
private

Definition at line 171 of file ROL_SemismoothNewtonProjection_Def.hpp.

◆ update_primal()

template<typename Real >
void ROL::SemismoothNewtonProjection< Real >::update_primal ( Vector< Real > & y,
const Vector< Real > & x,
const Vector< Real > & lam ) const
private

◆ project_ssn()

template<typename Real >
void ROL::SemismoothNewtonProjection< Real >::project_ssn ( Vector< Real > & x,
Vector< Real > & lam,
Vector< Real > & dlam,
std::ostream & stream = std::cout ) const
private

◆ compute_tolerance()

template<typename Real >
Real ROL::SemismoothNewtonProjection< Real >::compute_tolerance ( ) const
private

Member Data Documentation

◆ dim_

template<typename Real >
int ROL::SemismoothNewtonProjection< Real >::dim_
private

◆ krylov_

template<typename Real >
Ptr<Krylov<Real> > ROL::SemismoothNewtonProjection< Real >::krylov_
private

◆ xnew_

template<typename Real >
Ptr<Vector<Real> > ROL::SemismoothNewtonProjection< Real >::xnew_
private

◆ lnew_

template<typename Real >
Ptr<Vector<Real> > ROL::SemismoothNewtonProjection< Real >::lnew_
private

◆ dlam_

template<typename Real >
Ptr<Vector<Real> > ROL::SemismoothNewtonProjection< Real >::dlam_
private

◆ DEFAULT_atol_

template<typename Real >
Real ROL::SemismoothNewtonProjection< Real >::DEFAULT_atol_
private

◆ DEFAULT_rtol_

template<typename Real >
Real ROL::SemismoothNewtonProjection< Real >::DEFAULT_rtol_
private

◆ DEFAULT_stol_

template<typename Real >
Real ROL::SemismoothNewtonProjection< Real >::DEFAULT_stol_
private

◆ DEFAULT_decr_

template<typename Real >
Real ROL::SemismoothNewtonProjection< Real >::DEFAULT_decr_
private

◆ DEFAULT_factor_

template<typename Real >
Real ROL::SemismoothNewtonProjection< Real >::DEFAULT_factor_
private

◆ DEFAULT_regscale_

template<typename Real >
Real ROL::SemismoothNewtonProjection< Real >::DEFAULT_regscale_
private

◆ DEFAULT_errscale_

template<typename Real >
Real ROL::SemismoothNewtonProjection< Real >::DEFAULT_errscale_
private

◆ DEFAULT_maxit_

template<typename Real >
int ROL::SemismoothNewtonProjection< Real >::DEFAULT_maxit_
private

◆ DEFAULT_lstype_

template<typename Real >
int ROL::SemismoothNewtonProjection< Real >::DEFAULT_lstype_
private

◆ DEFAULT_verbosity_

template<typename Real >
int ROL::SemismoothNewtonProjection< Real >::DEFAULT_verbosity_
private

◆ DEFAULT_useproj_

template<typename Real >
bool ROL::SemismoothNewtonProjection< Real >::DEFAULT_useproj_
private

◆ atol_

template<typename Real >
Real ROL::SemismoothNewtonProjection< Real >::atol_
private

◆ rtol_

template<typename Real >
Real ROL::SemismoothNewtonProjection< Real >::rtol_
private

◆ stol_

template<typename Real >
Real ROL::SemismoothNewtonProjection< Real >::stol_
private

◆ decr_

template<typename Real >
Real ROL::SemismoothNewtonProjection< Real >::decr_
private

◆ factor_

template<typename Real >
Real ROL::SemismoothNewtonProjection< Real >::factor_
private

◆ regscale_

template<typename Real >
Real ROL::SemismoothNewtonProjection< Real >::regscale_
private

◆ errscale_

template<typename Real >
Real ROL::SemismoothNewtonProjection< Real >::errscale_
private

◆ ctol_

template<typename Real >
Real ROL::SemismoothNewtonProjection< Real >::ctol_
private

◆ maxit_

template<typename Real >
int ROL::SemismoothNewtonProjection< Real >::maxit_
private

◆ lstype_

template<typename Real >
int ROL::SemismoothNewtonProjection< Real >::lstype_
private

◆ verbosity_

template<typename Real >
int ROL::SemismoothNewtonProjection< Real >::verbosity_
private

◆ useproj_

template<typename Real >
bool ROL::SemismoothNewtonProjection< Real >::useproj_
private

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