MOOCHO (Single Doxygen Collection)  Version of the Day
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Groups Pages
Classes | Public Types | Public Member Functions | Static Private Member Functions | Private Attributes | List of all members
MoochoPack::DecompositionSystemStateStepBuilderStd Class Reference

Standard builder object for creating DecompositionSystem, EvalNewPoint Step and other objects and setting up some of the state object. More...

#include <MoochoPack_DecompositionSystemStateStepBuilderStd.hpp>

Classes

struct  SOptionValues
 

Public Types

typedef Teuchos::RCP< const
OptionsFromStreamPack::OptionsFromStream
options_ptr_t
 

Public Member Functions

 DecompositionSystemStateStepBuilderStd ()
 
void set_options (const options_ptr_t &options)
 Set the options that will be used to configure the algorithmic objects. More...
 
const options_ptr_tget_options () const
 
void process_nlp_and_options (std::ostream *trase_out, NLP &nlp, NLPFirstOrder **nlp_foi, NLPSecondOrder **nlp_soi, NLPDirect **nlp_fod, bool *tailored_approach)
 Process the NLP and process the options passed in from set_options(). Postconditions: More...
 
void create_decomp_sys (std::ostream *trase_out, NLP &nlp, NLPFirstOrder *nlp_foi, NLPSecondOrder *nlp_soi, NLPDirect *nlp_fod, bool tailored_approach, Teuchos::RCP< DecompositionSystem > *decomp_sys)
 Create the decomposition system object. More...
 
void add_iter_quantities (std::ostream *trase_out, NLP &nlp, NLPFirstOrder *nlp_foi, NLPSecondOrder *nlp_soi, NLPDirect *nlp_fod, bool tailored_approach, const Teuchos::RCP< DecompositionSystem > &decomp_sys, const Teuchos::RCP< NLPAlgoState > &state)
 Add the common iteration quantities to the state object. More...
 
void create_eval_new_point (std::ostream *trase_out, NLP &nlp, NLPFirstOrder *nlp_foi, NLPSecondOrder *nlp_soi, NLPDirect *nlp_fod, bool tailored_approach, const Teuchos::RCP< DecompositionSystem > &decomp_sys, Teuchos::RCP< IterationPack::AlgorithmStep > *eval_new_point_step, Teuchos::RCP< CalcFiniteDiffProd > *calc_fd_prod, Teuchos::RCP< VariableBoundsTester > *bounds_tester, Teuchos::RCP< NewDecompositionSelection_Strategy > *new_decomp_selection_strategy)
 Create the EvalNewPoint step object and allocated objects. More...
 
SOptionValuescurrent_option_values ()
 Return the current option values being used. More...
 

Static Private Member Functions

static void readin_options (const OptionsFromStreamPack::OptionsFromStream &options, SOptionValues *option_values, std::ostream *trase_out)
 Read in the options from a stream. More...
 
static void set_default_options (const SOptionValues &user_option_values, SOptionValues *current_option_values, std::ostream *trase_out)
 Set the defaults for options not set by the user. More...
 

Private Attributes

options_ptr_t options_
 Smart pointer to options. More...
 
SOptionValues uov_
 Options structs. More...
 
SOptionValues cov_
 
Teuchos::RCP< BasisSystemPerm > basis_sys_perm_
 

Enums for variaous options categories

enum  ENullSpaceMatrixType { NULL_SPACE_MATRIX_AUTO, NULL_SPACE_MATRIX_EXPLICIT, NULL_SPACE_MATRIX_IMPLICIT }
 
enum  ERangeSpaceMatrixType { RANGE_SPACE_MATRIX_AUTO, RANGE_SPACE_MATRIX_COORDINATE, RANGE_SPACE_MATRIX_ORTHOGONAL }
 

Detailed Description

Standard builder object for creating DecompositionSystem, EvalNewPoint Step and other objects and setting up some of the state object.

This class is designed to be used by NLPAlgoConfig subclasses based on SQP and performs many different tasks that are common to all of these algorithms.

ToDo: Finish documentation!

Definition at line 65 of file MoochoPack_DecompositionSystemStateStepBuilderStd.hpp.

Member Typedef Documentation

Member Enumeration Documentation

Enumerator
NULL_SPACE_MATRIX_AUTO 
NULL_SPACE_MATRIX_EXPLICIT 
NULL_SPACE_MATRIX_IMPLICIT 

Definition at line 73 of file MoochoPack_DecompositionSystemStateStepBuilderStd.hpp.

Enumerator
RANGE_SPACE_MATRIX_AUTO 
RANGE_SPACE_MATRIX_COORDINATE 
RANGE_SPACE_MATRIX_ORTHOGONAL 

Definition at line 77 of file MoochoPack_DecompositionSystemStateStepBuilderStd.hpp.

Constructor & Destructor Documentation

MoochoPack::DecompositionSystemStateStepBuilderStd::DecompositionSystemStateStepBuilderStd ( )

Member Function Documentation

void MoochoPack::DecompositionSystemStateStepBuilderStd::set_options ( const options_ptr_t options)

Set the options that will be used to configure the algorithmic objects.

Parameters
options[in] If NULL then no options will be set. If !=NULL then this is the OptionsFromStream object that will be used to extract the options to use for the algorithm. The state of this object must be maintained by the client until this object is no longer needed.

Definition at line 117 of file MoochoPack_DecompositionSystemStateStepBuilderStd.cpp.

const DecompositionSystemStateStepBuilderStd::options_ptr_t & MoochoPack::DecompositionSystemStateStepBuilderStd::get_options ( ) const
void MoochoPack::DecompositionSystemStateStepBuilderStd::process_nlp_and_options ( std::ostream *  trase_out,
NLP &  nlp,
NLPFirstOrder **  nlp_foi,
NLPSecondOrder **  nlp_soi,
NLPDirect **  nlp_fod,
bool *  tailored_approach 
)

Process the NLP and process the options passed in from set_options(). Postconditions:

ToDo: Finish documentation!

Definition at line 128 of file MoochoPack_DecompositionSystemStateStepBuilderStd.cpp.

void MoochoPack::DecompositionSystemStateStepBuilderStd::create_decomp_sys ( std::ostream *  trase_out,
NLP &  nlp,
NLPFirstOrder *  nlp_foi,
NLPSecondOrder *  nlp_soi,
NLPDirect *  nlp_fod,
bool  tailored_approach,
Teuchos::RCP< DecompositionSystem > *  decomp_sys 
)

Create the decomposition system object.

ToDo: Finish documentation!

Definition at line 226 of file MoochoPack_DecompositionSystemStateStepBuilderStd.cpp.

void MoochoPack::DecompositionSystemStateStepBuilderStd::add_iter_quantities ( std::ostream *  trase_out,
NLP &  nlp,
NLPFirstOrder *  nlp_foi,
NLPSecondOrder *  nlp_soi,
NLPDirect *  nlp_fod,
bool  tailored_approach,
const Teuchos::RCP< DecompositionSystem > &  decomp_sys,
const Teuchos::RCP< NLPAlgoState > &  state 
)

Add the common iteration quantities to the state object.

ToDo: Finish documentation!

Definition at line 348 of file MoochoPack_DecompositionSystemStateStepBuilderStd.cpp.

void MoochoPack::DecompositionSystemStateStepBuilderStd::create_eval_new_point ( std::ostream *  trase_out,
NLP &  nlp,
NLPFirstOrder *  nlp_foi,
NLPSecondOrder *  nlp_soi,
NLPDirect *  nlp_fod,
bool  tailored_approach,
const Teuchos::RCP< DecompositionSystem > &  decomp_sys,
Teuchos::RCP< IterationPack::AlgorithmStep > *  eval_new_point_step,
Teuchos::RCP< CalcFiniteDiffProd > *  calc_fd_prod,
Teuchos::RCP< VariableBoundsTester > *  bounds_tester,
Teuchos::RCP< NewDecompositionSelection_Strategy > *  new_decomp_selection_strategy 
)

Create the EvalNewPoint step object and allocated objects.

ToDo: Finish documentation!

Definition at line 530 of file MoochoPack_DecompositionSystemStateStepBuilderStd.cpp.

DecompositionSystemStateStepBuilderStd::SOptionValues & MoochoPack::DecompositionSystemStateStepBuilderStd::current_option_values ( )
inline

Return the current option values being used.

Definition at line 220 of file MoochoPack_DecompositionSystemStateStepBuilderStd.hpp.

void MoochoPack::DecompositionSystemStateStepBuilderStd::readin_options ( const OptionsFromStreamPack::OptionsFromStream options,
SOptionValues option_values,
std::ostream *  trase_out 
)
staticprivate

Read in the options from a stream.

Definition at line 697 of file MoochoPack_DecompositionSystemStateStepBuilderStd.cpp.

void MoochoPack::DecompositionSystemStateStepBuilderStd::set_default_options ( const SOptionValues user_option_values,
SOptionValues current_option_values,
std::ostream *  trase_out 
)
staticprivate

Set the defaults for options not set by the user.

Definition at line 783 of file MoochoPack_DecompositionSystemStateStepBuilderStd.cpp.

Member Data Documentation

options_ptr_t MoochoPack::DecompositionSystemStateStepBuilderStd::options_
private

Smart pointer to options.

Definition at line 187 of file MoochoPack_DecompositionSystemStateStepBuilderStd.hpp.

SOptionValues MoochoPack::DecompositionSystemStateStepBuilderStd::uov_
private

Options structs.

Definition at line 190 of file MoochoPack_DecompositionSystemStateStepBuilderStd.hpp.

SOptionValues MoochoPack::DecompositionSystemStateStepBuilderStd::cov_
private
Teuchos::RCP<BasisSystemPerm> MoochoPack::DecompositionSystemStateStepBuilderStd::basis_sys_perm_
private

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