MOOCHO (Single Doxygen Collection)
Version of the Day
|
#include <MoochoPack_IpState.hpp>
Public Member Functions | |
IpState (const decomp_sys_ptr_t &decomp_sys=Teuchos::null, const vec_space_ptr_t &space_x=Teuchos::null, const vec_space_ptr_t &space_c=Teuchos::null, const vec_space_ptr_t &space_range=Teuchos::null, const vec_space_ptr_t &space_null=Teuchos::null) | |
********** Iteration Quantities ************** More... | |
virtual | ~IpState () |
Public Member Functions inherited from MoochoPack::NLPAlgoState | |
STANDARD_COMPOSITION_MEMBERS (DecompositionSystem, decomp_sys) | |
Set the DecompositionSystem object that all share. More... | |
STANDARD_CONST_COMPOSITION_MEMBERS (VectorSpace, space_x) | |
Set the VectorSpace of x. More... | |
STANDARD_CONST_COMPOSITION_MEMBERS (VectorSpace, space_c) | |
Set the VectorSpace of c. More... | |
void | set_space_range (const vec_space_ptr_t &space_range) |
Set the VectorSpace of the range space (py). More... | |
vec_space_ptr_t & | get_space_range () |
const vec_space_ptr_t & | get_space_range () const |
const VectorSpace & | space_range () const |
void | set_space_null (const vec_space_ptr_t &space_null) |
Set the VectorSpace of the null space (pz). More... | |
vec_space_ptr_t & | get_space_null () |
const vec_space_ptr_t & | get_space_null () const |
const VectorSpace & | space_null () const |
NLPAlgoState (const decomp_sys_ptr_t &decomp_sys=Teuchos::null, const vec_space_ptr_t &space_x=Teuchos::null, const vec_space_ptr_t &space_c=Teuchos::null, const vec_space_ptr_t &space_range=Teuchos::null, const vec_space_ptr_t &space_null=Teuchos::null) | |
Construct. More... | |
virtual | ~NLPAlgoState () |
STANDARD_MEMBER_COMPOSITION_MEMBERS (Range1D, var_dep) | |
Range of dependent variables [1,r]. More... | |
STANDARD_MEMBER_COMPOSITION_MEMBERS (Range1D, var_indep) | |
Range of independent varaibles [r+1,n]. More... | |
STANDARD_MEMBER_COMPOSITION_MEMBERS (Range1D, equ_decomp) | |
Range of decomposed equality constraints [1,r]. More... | |
STANDARD_MEMBER_COMPOSITION_MEMBERS (Range1D, equ_undecomp) | |
Range of undecomposed equality constraints [r+1,m]. More... | |
STANDARD_COMPOSITION_MEMBERS (Permutation, P_var_current) | |
Current permutation for variables. More... | |
STANDARD_COMPOSITION_MEMBERS (Permutation, P_var_last) | |
Previous permutation for variables. More... | |
STANDARD_COMPOSITION_MEMBERS (Permutation, P_equ_current) | |
Current permutation for equality constraints. More... | |
STANDARD_COMPOSITION_MEMBERS (Permutation, P_equ_last) | |
Previous permutation for equality constraints. More... | |
Public Member Functions inherited from IterationPack::AlgorithmState | |
virtual | ~AlgorithmState () |
AlgorithmState (size_t reserve_size=0) | |
Construct with an initial guess for the number of iteration quantities. More... | |
void | k (int k) |
int | k () const |
int | incr_k () |
virtual size_t | num_iter_quant () const |
Return the number of iteration quantities. More... | |
virtual iq_id_type | set_iter_quant (const std::string &iq_name, const IQ_ptr &iq) |
Inserts the iteration quantity through a RCP<...> object. More... | |
virtual void | erase_iter_quant (const std::string &iq_name) |
Removes the iteration quantity with name iq_name. More... | |
virtual iq_id_type | get_iter_quant_id (const std::string &iq_name) const |
Return the iteration quantity id (iq_id) for the iteration quantity. More... | |
virtual IQ_ptr & | get_iter_quant (iq_id_type iq_id) |
Returns the RCP<...> for the iteration quantiy with iq_id. More... | |
virtual const IQ_ptr & | get_iter_quant (iq_id_type iq_id) const |
virtual IterQuantity & | iter_quant (const std::string &iq_name) |
Iteration quantity encapsulation object access with via iq_name. More... | |
virtual const IterQuantity & | iter_quant (const std::string &iq_name) const |
virtual IterQuantity & | iter_quant (iq_id_type iq_id) |
Iteration quantity encapsulation object access via iq_id. More... | |
virtual const IterQuantity & | iter_quant (iq_id_type iq_id) const |
virtual void | next_iteration (bool incr_k=true) |
iteration quantity forwarding. More... | |
virtual void | dump_iter_quant (std::ostream &out) const |
iteration quantity information dumping. More... | |
Additional Inherited Members | |
Public Types inherited from MoochoPack::NLPAlgoState | |
typedef Teuchos::RCP< const VectorSpace > | vec_space_ptr_t |
Public Types inherited from IterationPack::AlgorithmState | |
enum | { DOES_NOT_EXIST = INT_MAX } |
typedef size_t | iq_id_type |
typedef Teuchos::RCP < IterQuantity > | IQ_ptr |
Protected Types inherited from MoochoPack::NLPAlgoState | |
enum | { NUM_VEC_SPACE_TYPES = 5 } |
enum | EVecSpaceType { VST_SPACE_X = 0, VST_SPACE_C = 1, VST_SPACE_RANGE = 2, VST_SPACE_NULL = 3 } |
Protected Member Functions inherited from MoochoPack::NLPAlgoState | |
void | update_iq_id (const std::string &iq_name, iq_id_encap *iq_id) const |
void | update_index_type_iq_id (const std::string &iq_name, iq_id_encap *iq_id) |
void | update_value_type_iq_id (const std::string &iq_name, iq_id_encap *iq_id) |
void | update_vector_iq_id (const std::string &iq_name, const VectorSpace::space_ptr_t &vec_space, EVecSpaceType vec_space_type, iq_id_encap *iq_id) |
Definition at line 70 of file MoochoPack_IpState.hpp.
MoochoPack::IpState::IpState | ( | const decomp_sys_ptr_t & | decomp_sys = Teuchos::null , |
const vec_space_ptr_t & | space_x = Teuchos::null , |
||
const vec_space_ptr_t & | space_c = Teuchos::null , |
||
const vec_space_ptr_t & | space_range = Teuchos::null , |
||
const vec_space_ptr_t & | space_null = Teuchos::null |
||
) |
********** Iteration Quantities **************
mu: barrier parameter barrier_obj: objective value with grad_barrier_obj: gradient of the objective e_tol: current error tolerance for inner loop comp_err_mu: perturbed complementarity error for barrier sub problem Vu - diagonal matrix of upper bound multipliers Vl - diagonal matrix of lower bound multipliers invXu - (Xu)^-1 - matrix of 1/(xu-x) diagonal invXl - (Xl)^-1 - matrix of 1/(x-xl) diagonal rHB - reduced Hessian of the barrier term (Z_Sigma_Z) B - overall reduced 'Hessian' (Z_W_Z+Z_Sigma_Z) Full space Sigma (invXl*Vl-invXu*Vu) w_sigma: crossterm correction for sigma (Z' * Sigma * Y * py) dvl: Search direction for lower bound multipliers ( n x 1 ) dvu: Search direction for upper bound multipliers ( n x 1 ) alpha_vl: step size for vl alpha_vl: step size for vu Construct
Definition at line 66 of file MoochoPack_IpState.cpp.
|
virtual |
Definition at line 78 of file MoochoPack_IpState.cpp.