![]() |
QMCPACK
|
Public Member Functions | |
DescentEngine (Communicate *comm, const xmlNodePtr cur) | |
Constructor for engine. More... | |
bool | processXML (const xmlNodePtr cur) |
process xml node More... | |
void | prepareStorage (const int num_replicas, const int num_optimizables) |
Prepare for taking samples. More... | |
void | takeSample (const int replica_id, const std::vector< FullPrecValueType > &der_rat_samp, const std::vector< FullPrecValueType > &le_der_samp, const std::vector< FullPrecValueType > &ls_der_samp, ValueType vgs_samp, ValueType weight_samp) |
Function that Take Sample Data from the Host Code. More... | |
void | sample_finish () |
Function that reduces all vector information from all processors to the root processor. More... | |
void | mpi_unbiased_ratio_of_means (int numSamples, std::vector< ValueType > &weights, std::vector< ValueType > &numerSamples, std::vector< ValueType > &denomSamples, ValueType &mean, ValueType &variance, ValueType &stdErr) |
Function for computing ratios of the form <f>/<g> as well as the associated variance and standard error. More... | |
const std::vector< ValueType > & | getAveragedDerivatives () const |
Returns the derivatives of the cost function we are minimizing. More... | |
void | updateParameters () |
helper method for updating parameter values with descent More... | |
ValueType | setStepSize (int i) |
helper method for seting step sizes for different parameter types in descent optimization More... | |
void | storeDerivRecord () |
stores derivatives so they can be used in accelerated descent algorithm on later iterations More... | |
void | setupUpdate (const optimize::VariableSet &my_vars) |
helper method for transferring information on parameter names and types to the engine More... | |
void | storeVectors (std::vector< ValueType > ¤t_params) |
Store a vector of parameter differences to be used by the BLM in a hybrid optimization. More... | |
void | computeFinalizationUncertainties (std::vector< ValueType > &weights, std::vector< ValueType > &numerSamples, std::vector< ValueType > &denomSamples) |
Compute uncertainties for energy/target function and variance over a history of samples from a set of iterations. More... | |
int | retrieveStoreFrequency () const |
Returns number of times a parameter difference vector will be stored in the optimization. More... | |
const std::vector< std::vector< ValueType > > & | retrieveHybridBLM_Input () const |
Returns the set of stored parameter difference vectors that will be given to the BLM. More... | |
const std::vector< ValueType > & | retrieveNewParams () const |
Returns the current set of parameter values. More... | |
int | getDescentNum () const |
Returns number of optimization steps that have been taken with descent. More... | |
ValueType | getOmega () const |
Returns current value of omega. More... | |
ValueType | getEnergy () const |
Returns value of average energy. More... | |
ValueType | getVariance () const |
Returns variance of the energy. More... | |
ValueType | getSD () const |
Returns standard deviation of energy. More... | |
bool | targetingExcited () const |
Returns whether an excited state is being targeted. More... | |
int | getFinalDescentNum () const |
Returns the descent iteration number when on a finalizing descent section. More... | |
void | resetStorageCount () |
Resets the number of vectors stored to 0 for next hybrid method macro-iteration. More... | |
void | setDerivs (std::vector< ValueType > &test_derivs) |
Function for setting averaged derivatives, currently only used as part of a unit test of the engine's parameter update. More... | |
void | setParamVal (int index, ValueType value) |
Function for setting parameter value, used to keep descent parameter values up to date with changes that occur on BLM steps of hybrid method. More... | |
Private Types | |
using | FullPrecValueType = qmcplusplus::QMCTraits::FullPrecValueType |
using | ValueType = qmcplusplus::QMCTraits::ValueType |
using | RealType = qmcplusplus::QMCTraits::RealType |
using | FullPrecRealType = qmcplusplus::QMCTraits::FullPrecRealType |
Private Attributes | |
std::vector< FullPrecValueType > | avg_le_der_samp_ |
Vector for local energy parameter derivatives. More... | |
std::vector< std::vector< FullPrecValueType > > | replica_le_der_samp_ |
Vector for local energy parameter derivatives on one thread. More... | |
std::vector< FullPrecValueType > | avg_der_rat_samp_ |
Vector for WF parameter derivatives. More... | |
std::vector< std::vector< FullPrecValueType > > | replica_der_rat_samp_ |
Vector for WF parameter derivatives on one thread. More... | |
std::vector< FullPrecValueType > | avg_numer_der_samp_ |
Vector for target function numerator parameter derivatives. More... | |
std::vector< std::vector< FullPrecValueType > > | replica_numer_der_samp_ |
Vector for target function numerator parameter derivatives on one thread. More... | |
std::vector< FullPrecValueType > | avg_denom_der_samp_ |
Vector for target function denominator parameter derivatives. More... | |
std::vector< std::vector< FullPrecValueType > > | replica_denom_der_samp_ |
Vector for target function denominator parameter derivatives on one thread. More... | |
ValueType | w_sum_ |
Total sum of weights. More... | |
ValueType | e_avg_ |
Average energy on a descent step. More... | |
ValueType | e_var_ |
Variance of the energy. More... | |
ValueType | e_sd_ |
Standard deviation of the energy. More... | |
ValueType | e_err_ |
Standard error of the energy. More... | |
ValueType | numer_avg_ |
Average target function numerator on a descent step. More... | |
ValueType | numer_var_ |
Variance of the target function numerator. More... | |
ValueType | numer_err_ |
Standard error of the target function numerator. More... | |
ValueType | denom_avg_ |
Average target function denominator on a descent step. More... | |
ValueType | denom_var_ |
Variance of the target function denominator. More... | |
ValueType | denom_err_ |
Standard error of the target function denominator. More... | |
ValueType | target_avg_ |
Average target function value on a descent step. More... | |
ValueType | target_var_ |
Variance of the target function. More... | |
ValueType | target_err_ |
Standard error of the target function. More... | |
std::vector< ValueType > | vg_history_ |
history of sampled |value/guiding|^2 ratios for one iteration More... | |
std::vector< std::vector< ValueType > > | replica_vg_history_ |
std::vector< ValueType > | final_vg_history_ |
history of sampled |value/guiding|^2 ratios during the descent finalization phase More... | |
std::vector< std::vector< ValueType > > | replica_final_vg_history_ |
std::vector< ValueType > | w_history_ |
history of sampled configuration weights for one iteration More... | |
std::vector< std::vector< ValueType > > | replica_w_history_ |
std::vector< ValueType > | final_w_history_ |
history of sampled configuration weights during descent finalization phase More... | |
std::vector< std::vector< ValueType > > | replica_final_w_history_ |
std::vector< ValueType > | lev_history_ |
a history of sampled local energies times the |value/guiding|^2 raitos for one iteration More... | |
std::vector< std::vector< ValueType > > | replica_lev_history_ |
std::vector< ValueType > | final_lev_history_ |
history of sampled local energies times the |value/guiding|^2 raitos during the descent finalization phase More... | |
std::vector< std::vector< ValueType > > | replica_final_lev_history_ |
std::vector< ValueType > | final_le_avg_history_ |
a vector to store the averages of the energy during the descent finalization phase More... | |
std::vector< ValueType > | final_var_avg_history_ |
a vector to store the variances of the energy during the descent finalization phase More... | |
std::vector< ValueType > | tnv_history_ |
a history of target function numerator times the |value/guiding|^2 ratios for one iteration More... | |
std::vector< std::vector< ValueType > > | replica_tnv_history_ |
std::vector< ValueType > | final_tnv_history_ |
a history of target function numerator times the |value/guiding|^2 ratios during the descent finalization phase More... | |
std::vector< std::vector< ValueType > > | replica_final_tnv_history_ |
std::vector< ValueType > | tdv_history_ |
a history of target function denominator times the |value/guiding|^2 ratios for one iteration More... | |
std::vector< std::vector< ValueType > > | replica_tdv_history_ |
std::vector< ValueType > | final_tdv_history_ |
a history of target function denomerator times the |value/guiding|^2 ratios during the descent finalization phase More... | |
std::vector< std::vector< ValueType > > | replica_final_tdv_history_ |
std::vector< ValueType > | final_tar_avg_history_ |
a vector to store the averages of the target function during the descent finalization phase More... | |
std::vector< ValueType > | final_tar_var_history_ |
a vector to store the variances of the target function during the descent finalization phase More... | |
std::vector< ValueType > | lderivs_ |
Vector that stores the final averaged derivatives of the cost function. More... | |
Communicate * | my_comm_ |
Communicator handles MPI reduction. More... | |
bool | engine_target_excited_ |
Whether to target excited state. More... | |
int | num_params_ |
Number of optimizable parameters. More... | |
std::vector< ValueType > | params_copy_ |
Vector for storing parameter values from previous optimization step. More... | |
std::vector< ValueType > | current_params_ |
Vector for storing parameter values for current optimization step. More... | |
std::vector< std::vector< ValueType > > | deriv_records_ |
Vector for storing Lagrangian derivatives from previous optimization steps. More... | |
std::vector< ValueType > | denom_records_ |
Vector for storing step size denominator values from previous optimization step. More... | |
std::vector< ValueType > | numer_records_ |
Vector for storing step size numerator values from previous optimization step. More... | |
ValueType | lambda_ = 0.0 |
Parameter for accelerated descent recursion relation. More... | |
std::vector< ValueType > | taus_ |
Vector for storing step sizes from previous optimization step. More... | |
std::vector< ValueType > | derivs_squared_ |
Vector for storing running average of squares of the derivatives. More... | |
int | descent_num_ |
Integer for keeping track of only number of descent steps taken. More... | |
std::string | flavor_ |
What variety of gradient descent will be used. More... | |
ValueType | tjf_2body_eta_ |
Step sizes for different types of parameters. More... | |
ValueType | tjf_1body_eta_ |
ValueType | f_eta_ |
ValueType | gauss_eta_ |
ValueType | ci_eta_ |
ValueType | orb_eta_ |
bool | ramp_eta_ |
Whether to gradually ramp up step sizes in descent. More... | |
int | ramp_num_ |
Number of steps over which to ramp up step size. More... | |
int | store_num_ |
Number of parameter difference vectors stored when descent is used in a hybrid optimization. More... | |
int | store_count_ |
Counter of how many vectors have been stored so far. More... | |
std::vector< std::string > | engine_param_names_ |
Vectors of parameter names and types, used in the assignment of step sizes. More... | |
std::vector< int > | engine_param_types_ |
std::vector< ValueType > | params_for_diff_ |
Vector for storing parameter values for calculating differences to be given to hybrid method. More... | |
std::vector< std::vector< ValueType > > | hybrid_blm_input_ |
Vector for storing the input vectors to the BLM steps of hybrid method. More... | |
ValueType | omega_ |
Value of omega in excited state functional. More... | |
int | collection_step_ |
Iteration to start collecting samples for final average and error blocking analysis. More... | |
int | compute_step_ |
Iteration to start computing averages and errors from the stored values during the finalization phase. More... | |
bool | collect_count_ = false |
Whether to start collecting samples for the histories in the finalization phase. More... | |
int | final_descent_num_ = 0 |
Counter for the number of descent steps taken in the finalization phase. More... | |
std::string | print_deriv_ |
Whether to print out derivative terms for each parameter. More... | |
Definition at line 27 of file DescentEngine.h.
|
private |
Definition at line 32 of file DescentEngine.h.
|
private |
Definition at line 29 of file DescentEngine.h.
|
private |
Definition at line 31 of file DescentEngine.h.
|
private |
Definition at line 30 of file DescentEngine.h.
DescentEngine | ( | Communicate * | comm, |
const xmlNodePtr | cur | ||
) |
Constructor for engine.
Definition at line 29 of file DescentEngine.cpp.
References DescentEngine::descent_num_, DescentEngine::processXML(), and DescentEngine::store_count_.
void computeFinalizationUncertainties | ( | std::vector< ValueType > & | weights, |
std::vector< ValueType > & | numerSamples, | ||
std::vector< ValueType > & | denomSamples | ||
) |
Compute uncertainties for energy/target function and variance over a history of samples from a set of iterations.
Definition at line 966 of file DescentEngine.cpp.
References qmcplusplus::abs(), qmcplusplus::app_log(), copy(), DescentEngine::mpi_unbiased_ratio_of_means(), qmcplusplus::n, and qmcplusplus::sqrt().
Referenced by DescentEngine::updateParameters().
|
inline |
Returns the derivatives of the cost function we are minimizing.
Definition at line 293 of file DescentEngine.h.
References DescentEngine::lderivs_.
|
inline |
Returns number of optimization steps that have been taken with descent.
Definition at line 332 of file DescentEngine.h.
References DescentEngine::descent_num_.
|
inline |
Returns value of average energy.
Definition at line 338 of file DescentEngine.h.
References DescentEngine::e_avg_.
|
inline |
Returns the descent iteration number when on a finalizing descent section.
Definition at line 350 of file DescentEngine.h.
References DescentEngine::final_descent_num_.
|
inline |
Returns current value of omega.
Definition at line 335 of file DescentEngine.h.
References DescentEngine::omega_.
|
inline |
Returns standard deviation of energy.
Definition at line 344 of file DescentEngine.h.
References DescentEngine::e_sd_.
|
inline |
Returns variance of the energy.
Definition at line 341 of file DescentEngine.h.
References DescentEngine::e_var_.
void mpi_unbiased_ratio_of_means | ( | int | numSamples, |
std::vector< ValueType > & | weights, | ||
std::vector< ValueType > & | numerSamples, | ||
std::vector< ValueType > & | denomSamples, | ||
ValueType & | mean, | ||
ValueType & | variance, | ||
ValueType & | stdErr | ||
) |
Function for computing ratios of the form <f>/<g> as well as the associated variance and standard error.
Definition at line 481 of file DescentEngine.cpp.
References Communicate::allreduce(), mean(), qmcplusplus::Units::mass::mp, DescentEngine::my_comm_, qmcplusplus::n, qmcplusplus::Units::time::ns, qmcplusplus::sqrt(), and DescentEngine::w_sum_.
Referenced by DescentEngine::computeFinalizationUncertainties(), and DescentEngine::sample_finish().
void prepareStorage | ( | const int | num_replicas, |
const int | num_optimizables | ||
) |
Prepare for taking samples.
Definition at line 103 of file DescentEngine.cpp.
References DescentEngine::avg_denom_der_samp_, DescentEngine::avg_der_rat_samp_, DescentEngine::avg_le_der_samp_, DescentEngine::avg_numer_der_samp_, DescentEngine::collect_count_, DescentEngine::collection_step_, DescentEngine::denom_avg_, DescentEngine::denom_err_, DescentEngine::denom_var_, DescentEngine::e_avg_, DescentEngine::e_err_, DescentEngine::e_sd_, DescentEngine::e_var_, DescentEngine::engine_target_excited_, DescentEngine::final_descent_num_, DescentEngine::lderivs_, DescentEngine::num_params_, DescentEngine::numer_avg_, DescentEngine::numer_err_, DescentEngine::numer_var_, DescentEngine::replica_denom_der_samp_, DescentEngine::replica_der_rat_samp_, DescentEngine::replica_final_lev_history_, DescentEngine::replica_final_tdv_history_, DescentEngine::replica_final_tnv_history_, DescentEngine::replica_final_vg_history_, DescentEngine::replica_final_w_history_, DescentEngine::replica_le_der_samp_, DescentEngine::replica_lev_history_, DescentEngine::replica_numer_der_samp_, DescentEngine::replica_tdv_history_, DescentEngine::replica_tnv_history_, DescentEngine::replica_vg_history_, DescentEngine::replica_w_history_, DescentEngine::target_avg_, DescentEngine::target_err_, DescentEngine::target_var_, and DescentEngine::w_sum_.
Referenced by DescentEngineHandle::prepareSampling().
bool processXML | ( | const xmlNodePtr | cur | ) |
process xml node
Definition at line 53 of file DescentEngine.cpp.
References ParameterSet::add(), qmcplusplus::app_log(), DescentEngine::ci_eta_, DescentEngine::collect_count_, DescentEngine::collection_step_, DescentEngine::compute_step_, DescentEngine::engine_target_excited_, DescentEngine::f_eta_, DescentEngine::flavor_, DescentEngine::gauss_eta_, DescentEngine::omega_, DescentEngine::orb_eta_, DescentEngine::print_deriv_, ParameterSet::put(), DescentEngine::ramp_eta_, DescentEngine::ramp_num_, DescentEngine::store_num_, DescentEngine::tjf_1body_eta_, and DescentEngine::tjf_2body_eta_.
Referenced by DescentEngine::DescentEngine(), and qmcplusplus::TEST_CASE().
|
inline |
Resets the number of vectors stored to 0 for next hybrid method macro-iteration.
Definition at line 354 of file DescentEngine.h.
References DescentEngine::store_count_.
|
inline |
Returns the set of stored parameter difference vectors that will be given to the BLM.
Definition at line 326 of file DescentEngine.h.
References DescentEngine::hybrid_blm_input_.
|
inline |
Returns the current set of parameter values.
Definition at line 329 of file DescentEngine.h.
References DescentEngine::current_params_.
|
inline |
Returns number of times a parameter difference vector will be stored in the optimization.
Definition at line 322 of file DescentEngine.h.
References DescentEngine::store_num_.
void sample_finish | ( | ) |
Function that reduces all vector information from all processors to the root processor.
Definition at line 292 of file DescentEngine.cpp.
References Communicate::allreduce(), qmcplusplus::app_log(), DescentEngine::avg_denom_der_samp_, DescentEngine::avg_der_rat_samp_, DescentEngine::avg_le_der_samp_, DescentEngine::avg_numer_der_samp_, DescentEngine::collect_count_, DescentEngine::collection_step_, DescentEngine::denom_avg_, DescentEngine::denom_err_, DescentEngine::denom_var_, DescentEngine::e_avg_, DescentEngine::e_err_, DescentEngine::e_sd_, DescentEngine::e_var_, DescentEngine::engine_target_excited_, DescentEngine::final_descent_num_, DescentEngine::final_le_avg_history_, DescentEngine::final_lev_history_, DescentEngine::final_tar_avg_history_, DescentEngine::final_tar_var_history_, DescentEngine::final_tdv_history_, DescentEngine::final_tnv_history_, DescentEngine::final_var_avg_history_, DescentEngine::final_vg_history_, DescentEngine::final_w_history_, DescentEngine::lderivs_, DescentEngine::lev_history_, DescentEngine::mpi_unbiased_ratio_of_means(), DescentEngine::my_comm_, DescentEngine::numer_avg_, DescentEngine::numer_err_, DescentEngine::numer_var_, DescentEngine::print_deriv_, DescentEngine::replica_denom_der_samp_, DescentEngine::replica_der_rat_samp_, DescentEngine::replica_final_lev_history_, DescentEngine::replica_final_tdv_history_, DescentEngine::replica_final_tnv_history_, DescentEngine::replica_final_vg_history_, DescentEngine::replica_final_w_history_, DescentEngine::replica_le_der_samp_, DescentEngine::replica_lev_history_, DescentEngine::replica_numer_der_samp_, DescentEngine::replica_tdv_history_, DescentEngine::replica_tnv_history_, DescentEngine::replica_vg_history_, DescentEngine::replica_w_history_, qmcplusplus::sqrt(), DescentEngine::target_avg_, DescentEngine::target_err_, DescentEngine::target_var_, DescentEngine::tdv_history_, DescentEngine::tnv_history_, DescentEngine::vg_history_, DescentEngine::w_history_, and DescentEngine::w_sum_.
Referenced by DescentEngineHandle::finishSampling().
|
inline |
Function for setting averaged derivatives, currently only used as part of a unit test of the engine's parameter update.
Definition at line 358 of file DescentEngine.h.
References DescentEngine::lderivs_.
|
inline |
Function for setting parameter value, used to keep descent parameter values up to date with changes that occur on BLM steps of hybrid method.
Definition at line 362 of file DescentEngine.h.
References DescentEngine::current_params_.
DescentEngine::ValueType setStepSize | ( | int | i | ) |
helper method for seting step sizes for different parameter types in descent optimization
Definition at line 844 of file DescentEngine.cpp.
References DescentEngine::ci_eta_, DescentEngine::descent_num_, DescentEngine::engine_param_names_, DescentEngine::engine_param_types_, DescentEngine::f_eta_, DescentEngine::gauss_eta_, DescentEngine::orb_eta_, DescentEngine::ramp_eta_, DescentEngine::ramp_num_, DescentEngine::tjf_1body_eta_, and DescentEngine::tjf_2body_eta_.
Referenced by DescentEngine::updateParameters().
void setupUpdate | ( | const optimize::VariableSet & | my_vars | ) |
helper method for transferring information on parameter names and types to the engine
Definition at line 901 of file DescentEngine.cpp.
References qmcplusplus::app_log(), DescentEngine::current_params_, DescentEngine::engine_param_names_, DescentEngine::engine_param_types_, VariableSet::getType(), VariableSet::name(), DescentEngine::num_params_, DescentEngine::params_copy_, DescentEngine::params_for_diff_, VariableSet::size(), and VariableSet::where().
|
inline |
stores derivatives so they can be used in accelerated descent algorithm on later iterations
Definition at line 304 of file DescentEngine.h.
References DescentEngine::deriv_records_, and DescentEngine::lderivs_.
void storeVectors | ( | std::vector< ValueType > & | current_params | ) |
Store a vector of parameter differences to be used by the BLM in a hybrid optimization.
Definition at line 924 of file DescentEngine.cpp.
References qmcplusplus::app_log(), DescentEngine::hybrid_blm_input_, DescentEngine::params_for_diff_, and DescentEngine::store_count_.
void takeSample | ( | const int | replica_id, |
const std::vector< FullPrecValueType > & | der_rat_samp, | ||
const std::vector< FullPrecValueType > & | le_der_samp, | ||
const std::vector< FullPrecValueType > & | ls_der_samp, | ||
ValueType | vgs_samp, | ||
ValueType | weight_samp | ||
) |
Function that Take Sample Data from the Host Code.
[in] | der_rat_samp | <n|Psi_i>/<n|Psi> (i = 0 (|Psi>), 1, ... N_var ) |
[in] | le_der_samp | <n|H|Psi_i>/<n|Psi> (i = 0 (|Psi>), 1, ... N_var ) |
[in] | ls_der_samp | <|S^2|Psi_i>/<n|Psi> (i = 0 (|Psi>), 1, ... N_var ) |
[in] | vgs_samp | |<n|value_fn>/<n|guiding_fn>|^2 |
[in] | weight_samp | weight for this sample |
Definition at line 214 of file DescentEngine.cpp.
References DescentEngine::collect_count_, DescentEngine::collection_step_, DescentEngine::engine_target_excited_, DescentEngine::final_descent_num_, qmcplusplus::n, DescentEngine::omega_, DescentEngine::replica_denom_der_samp_, DescentEngine::replica_der_rat_samp_, DescentEngine::replica_final_lev_history_, DescentEngine::replica_final_tdv_history_, DescentEngine::replica_final_tnv_history_, DescentEngine::replica_final_vg_history_, DescentEngine::replica_final_w_history_, DescentEngine::replica_le_der_samp_, DescentEngine::replica_lev_history_, DescentEngine::replica_numer_der_samp_, DescentEngine::replica_tdv_history_, DescentEngine::replica_tnv_history_, DescentEngine::replica_vg_history_, and DescentEngine::replica_w_history_.
Referenced by DescentEngineHandle::takeSample().
|
inline |
Returns whether an excited state is being targeted.
Definition at line 347 of file DescentEngine.h.
References DescentEngine::engine_target_excited_.
void updateParameters | ( | ) |
helper method for updating parameter values with descent
Definition at line 532 of file DescentEngine.cpp.
References qmcplusplus::abs(), qmcplusplus::app_log(), DescentEngine::ci_eta_, DescentEngine::collect_count_, DescentEngine::collection_step_, DescentEngine::compute_step_, DescentEngine::computeFinalizationUncertainties(), DescentEngine::current_params_, DescentEngine::denom_records_, DescentEngine::deriv_records_, DescentEngine::derivs_squared_, DescentEngine::descent_num_, qmcplusplus::Units::charge::e, DescentEngine::engine_target_excited_, qmcplusplus::exp(), DescentEngine::f_eta_, DescentEngine::final_descent_num_, DescentEngine::final_le_avg_history_, DescentEngine::final_lev_history_, DescentEngine::final_tar_avg_history_, DescentEngine::final_tar_var_history_, DescentEngine::final_tdv_history_, DescentEngine::final_tnv_history_, DescentEngine::final_var_avg_history_, DescentEngine::final_vg_history_, DescentEngine::final_w_history_, DescentEngine::flavor_, qmcplusplus::isnan(), DescentEngine::lambda_, DescentEngine::num_params_, DescentEngine::numer_records_, DescentEngine::orb_eta_, DescentEngine::params_copy_, qmcplusplus::pow(), DescentEngine::setStepSize(), sign(), qmcplusplus::sqrt(), DescentEngine::taus_, DescentEngine::tjf_1body_eta_, and DescentEngine::tjf_2body_eta_.
|
private |
Vector for target function denominator parameter derivatives.
Definition at line 51 of file DescentEngine.h.
Referenced by DescentEngine::prepareStorage(), and DescentEngine::sample_finish().
|
private |
Vector for WF parameter derivatives.
Definition at line 41 of file DescentEngine.h.
Referenced by DescentEngine::prepareStorage(), and DescentEngine::sample_finish().
|
private |
Vector for local energy parameter derivatives.
Definition at line 36 of file DescentEngine.h.
Referenced by DescentEngine::prepareStorage(), and DescentEngine::sample_finish().
|
private |
Vector for target function numerator parameter derivatives.
Definition at line 46 of file DescentEngine.h.
Referenced by DescentEngine::prepareStorage(), and DescentEngine::sample_finish().
|
private |
Definition at line 196 of file DescentEngine.h.
Referenced by DescentEngine::processXML(), DescentEngine::setStepSize(), and DescentEngine::updateParameters().
|
private |
Whether to start collecting samples for the histories in the finalization phase.
Definition at line 236 of file DescentEngine.h.
Referenced by DescentEngine::prepareStorage(), DescentEngine::processXML(), DescentEngine::sample_finish(), DescentEngine::takeSample(), and DescentEngine::updateParameters().
|
private |
Iteration to start collecting samples for final average and error blocking analysis.
Definition at line 228 of file DescentEngine.h.
Referenced by DescentEngine::prepareStorage(), DescentEngine::processXML(), DescentEngine::sample_finish(), DescentEngine::takeSample(), and DescentEngine::updateParameters().
|
private |
Iteration to start computing averages and errors from the stored values during the finalization phase.
Definition at line 232 of file DescentEngine.h.
Referenced by DescentEngine::processXML(), and DescentEngine::updateParameters().
|
private |
Vector for storing parameter values for current optimization step.
Definition at line 165 of file DescentEngine.h.
Referenced by DescentEngine::retrieveNewParams(), DescentEngine::setParamVal(), DescentEngine::setupUpdate(), and DescentEngine::updateParameters().
|
private |
Average target function denominator on a descent step.
Definition at line 75 of file DescentEngine.h.
Referenced by DescentEngine::prepareStorage(), and DescentEngine::sample_finish().
|
private |
Standard error of the target function denominator.
Definition at line 79 of file DescentEngine.h.
Referenced by DescentEngine::prepareStorage(), and DescentEngine::sample_finish().
|
private |
Vector for storing step size denominator values from previous optimization step.
Definition at line 172 of file DescentEngine.h.
Referenced by DescentEngine::updateParameters().
|
private |
Variance of the target function denominator.
Definition at line 77 of file DescentEngine.h.
Referenced by DescentEngine::prepareStorage(), and DescentEngine::sample_finish().
|
private |
Vector for storing Lagrangian derivatives from previous optimization steps.
Definition at line 168 of file DescentEngine.h.
Referenced by DescentEngine::storeDerivRecord(), and DescentEngine::updateParameters().
|
private |
Vector for storing running average of squares of the derivatives.
Definition at line 183 of file DescentEngine.h.
Referenced by DescentEngine::updateParameters().
|
private |
Integer for keeping track of only number of descent steps taken.
Definition at line 186 of file DescentEngine.h.
Referenced by DescentEngine::DescentEngine(), DescentEngine::getDescentNum(), DescentEngine::setStepSize(), and DescentEngine::updateParameters().
|
private |
Average energy on a descent step.
Definition at line 59 of file DescentEngine.h.
Referenced by DescentEngine::getEnergy(), DescentEngine::prepareStorage(), and DescentEngine::sample_finish().
|
private |
Standard error of the energy.
Definition at line 65 of file DescentEngine.h.
Referenced by DescentEngine::prepareStorage(), and DescentEngine::sample_finish().
|
private |
Standard deviation of the energy.
Definition at line 63 of file DescentEngine.h.
Referenced by DescentEngine::getSD(), DescentEngine::prepareStorage(), and DescentEngine::sample_finish().
|
private |
Variance of the energy.
Definition at line 61 of file DescentEngine.h.
Referenced by DescentEngine::getVariance(), DescentEngine::prepareStorage(), and DescentEngine::sample_finish().
|
private |
Vectors of parameter names and types, used in the assignment of step sizes.
Definition at line 213 of file DescentEngine.h.
Referenced by DescentEngine::setStepSize(), and DescentEngine::setupUpdate().
|
private |
Definition at line 214 of file DescentEngine.h.
Referenced by DescentEngine::setStepSize(), and DescentEngine::setupUpdate().
|
private |
Whether to target excited state.
Definition at line 156 of file DescentEngine.h.
Referenced by DescentEngine::prepareStorage(), DescentEngine::processXML(), DescentEngine::sample_finish(), DescentEngine::takeSample(), DescentEngine::targetingExcited(), and DescentEngine::updateParameters().
|
private |
Definition at line 194 of file DescentEngine.h.
Referenced by DescentEngine::processXML(), DescentEngine::setStepSize(), and DescentEngine::updateParameters().
|
private |
Counter for the number of descent steps taken in the finalization phase.
Definition at line 239 of file DescentEngine.h.
Referenced by DescentEngine::getFinalDescentNum(), DescentEngine::prepareStorage(), DescentEngine::sample_finish(), DescentEngine::takeSample(), and DescentEngine::updateParameters().
|
private |
a vector to store the averages of the energy during the descent finalization phase
Definition at line 117 of file DescentEngine.h.
Referenced by DescentEngine::sample_finish(), and DescentEngine::updateParameters().
|
private |
history of sampled local energies times the |value/guiding|^2 raitos during the descent finalization phase
Definition at line 112 of file DescentEngine.h.
Referenced by DescentEngine::sample_finish(), and DescentEngine::updateParameters().
|
private |
a vector to store the averages of the target function during the descent finalization phase
Definition at line 144 of file DescentEngine.h.
Referenced by DescentEngine::sample_finish(), and DescentEngine::updateParameters().
|
private |
a vector to store the variances of the target function during the descent finalization phase
Definition at line 147 of file DescentEngine.h.
Referenced by DescentEngine::sample_finish(), and DescentEngine::updateParameters().
|
private |
a history of target function denomerator times the |value/guiding|^2 ratios during the descent finalization phase
Definition at line 139 of file DescentEngine.h.
Referenced by DescentEngine::sample_finish(), and DescentEngine::updateParameters().
|
private |
a history of target function numerator times the |value/guiding|^2 ratios during the descent finalization phase
Definition at line 130 of file DescentEngine.h.
Referenced by DescentEngine::sample_finish(), and DescentEngine::updateParameters().
|
private |
a vector to store the variances of the energy during the descent finalization phase
Definition at line 121 of file DescentEngine.h.
Referenced by DescentEngine::sample_finish(), and DescentEngine::updateParameters().
|
private |
history of sampled |value/guiding|^2 ratios during the descent finalization phase
Definition at line 94 of file DescentEngine.h.
Referenced by DescentEngine::sample_finish(), and DescentEngine::updateParameters().
|
private |
history of sampled configuration weights during descent finalization phase
Definition at line 102 of file DescentEngine.h.
Referenced by DescentEngine::sample_finish(), and DescentEngine::updateParameters().
|
private |
What variety of gradient descent will be used.
Definition at line 189 of file DescentEngine.h.
Referenced by DescentEngine::processXML(), and DescentEngine::updateParameters().
|
private |
Definition at line 195 of file DescentEngine.h.
Referenced by DescentEngine::processXML(), and DescentEngine::setStepSize().
|
private |
Vector for storing the input vectors to the BLM steps of hybrid method.
Definition at line 221 of file DescentEngine.h.
Referenced by DescentEngine::retrieveHybridBLM_Input(), and DescentEngine::storeVectors().
|
private |
Parameter for accelerated descent recursion relation.
Definition at line 179 of file DescentEngine.h.
Referenced by DescentEngine::updateParameters().
|
private |
Vector that stores the final averaged derivatives of the cost function.
Definition at line 150 of file DescentEngine.h.
Referenced by DescentEngine::getAveragedDerivatives(), DescentEngine::prepareStorage(), DescentEngine::sample_finish(), DescentEngine::setDerivs(), and DescentEngine::storeDerivRecord().
|
private |
a history of sampled local energies times the |value/guiding|^2 raitos for one iteration
Definition at line 107 of file DescentEngine.h.
Referenced by DescentEngine::sample_finish().
|
private |
Communicator handles MPI reduction.
Definition at line 153 of file DescentEngine.h.
Referenced by DescentEngine::mpi_unbiased_ratio_of_means(), and DescentEngine::sample_finish().
|
private |
Number of optimizable parameters.
Definition at line 159 of file DescentEngine.h.
Referenced by DescentEngine::prepareStorage(), DescentEngine::setupUpdate(), and DescentEngine::updateParameters().
|
private |
Average target function numerator on a descent step.
Definition at line 68 of file DescentEngine.h.
Referenced by DescentEngine::prepareStorage(), and DescentEngine::sample_finish().
|
private |
Standard error of the target function numerator.
Definition at line 72 of file DescentEngine.h.
Referenced by DescentEngine::prepareStorage(), and DescentEngine::sample_finish().
|
private |
Vector for storing step size numerator values from previous optimization step.
Definition at line 176 of file DescentEngine.h.
Referenced by DescentEngine::updateParameters().
|
private |
Variance of the target function numerator.
Definition at line 70 of file DescentEngine.h.
Referenced by DescentEngine::prepareStorage(), and DescentEngine::sample_finish().
|
private |
Value of omega in excited state functional.
Definition at line 224 of file DescentEngine.h.
Referenced by DescentEngine::getOmega(), DescentEngine::processXML(), and DescentEngine::takeSample().
|
private |
Definition at line 197 of file DescentEngine.h.
Referenced by DescentEngine::processXML(), DescentEngine::setStepSize(), and DescentEngine::updateParameters().
|
private |
Vector for storing parameter values from previous optimization step.
Definition at line 162 of file DescentEngine.h.
Referenced by DescentEngine::setupUpdate(), and DescentEngine::updateParameters().
|
private |
Vector for storing parameter values for calculating differences to be given to hybrid method.
Definition at line 218 of file DescentEngine.h.
Referenced by DescentEngine::setupUpdate(), and DescentEngine::storeVectors().
|
private |
Whether to print out derivative terms for each parameter.
Definition at line 242 of file DescentEngine.h.
Referenced by DescentEngine::processXML(), and DescentEngine::sample_finish().
|
private |
Whether to gradually ramp up step sizes in descent.
Definition at line 200 of file DescentEngine.h.
Referenced by DescentEngine::processXML(), and DescentEngine::setStepSize().
|
private |
Number of steps over which to ramp up step size.
Definition at line 203 of file DescentEngine.h.
Referenced by DescentEngine::processXML(), and DescentEngine::setStepSize().
|
private |
Vector for target function denominator parameter derivatives on one thread.
Definition at line 53 of file DescentEngine.h.
Referenced by DescentEngine::prepareStorage(), DescentEngine::sample_finish(), and DescentEngine::takeSample().
|
private |
Vector for WF parameter derivatives on one thread.
Definition at line 43 of file DescentEngine.h.
Referenced by DescentEngine::prepareStorage(), DescentEngine::sample_finish(), and DescentEngine::takeSample().
|
private |
Definition at line 113 of file DescentEngine.h.
Referenced by DescentEngine::prepareStorage(), DescentEngine::sample_finish(), and DescentEngine::takeSample().
|
private |
Definition at line 140 of file DescentEngine.h.
Referenced by DescentEngine::prepareStorage(), DescentEngine::sample_finish(), and DescentEngine::takeSample().
|
private |
Definition at line 131 of file DescentEngine.h.
Referenced by DescentEngine::prepareStorage(), DescentEngine::sample_finish(), and DescentEngine::takeSample().
|
private |
Definition at line 95 of file DescentEngine.h.
Referenced by DescentEngine::prepareStorage(), DescentEngine::sample_finish(), and DescentEngine::takeSample().
|
private |
Definition at line 103 of file DescentEngine.h.
Referenced by DescentEngine::prepareStorage(), DescentEngine::sample_finish(), and DescentEngine::takeSample().
|
private |
Vector for local energy parameter derivatives on one thread.
Definition at line 38 of file DescentEngine.h.
Referenced by DescentEngine::prepareStorage(), DescentEngine::sample_finish(), and DescentEngine::takeSample().
|
private |
Definition at line 108 of file DescentEngine.h.
Referenced by DescentEngine::prepareStorage(), DescentEngine::sample_finish(), and DescentEngine::takeSample().
|
private |
Vector for target function numerator parameter derivatives on one thread.
Definition at line 48 of file DescentEngine.h.
Referenced by DescentEngine::prepareStorage(), DescentEngine::sample_finish(), and DescentEngine::takeSample().
|
private |
Definition at line 136 of file DescentEngine.h.
Referenced by DescentEngine::prepareStorage(), DescentEngine::sample_finish(), and DescentEngine::takeSample().
|
private |
Definition at line 126 of file DescentEngine.h.
Referenced by DescentEngine::prepareStorage(), DescentEngine::sample_finish(), and DescentEngine::takeSample().
|
private |
Definition at line 90 of file DescentEngine.h.
Referenced by DescentEngine::prepareStorage(), DescentEngine::sample_finish(), and DescentEngine::takeSample().
|
private |
Definition at line 100 of file DescentEngine.h.
Referenced by DescentEngine::prepareStorage(), DescentEngine::sample_finish(), and DescentEngine::takeSample().
|
private |
Counter of how many vectors have been stored so far.
Definition at line 210 of file DescentEngine.h.
Referenced by DescentEngine::DescentEngine(), DescentEngine::resetStorageCount(), and DescentEngine::storeVectors().
|
private |
Number of parameter difference vectors stored when descent is used in a hybrid optimization.
Definition at line 207 of file DescentEngine.h.
Referenced by DescentEngine::processXML(), and DescentEngine::retrieveStoreFrequency().
|
private |
Average target function value on a descent step.
Definition at line 82 of file DescentEngine.h.
Referenced by DescentEngine::prepareStorage(), and DescentEngine::sample_finish().
|
private |
Standard error of the target function.
Definition at line 86 of file DescentEngine.h.
Referenced by DescentEngine::prepareStorage(), and DescentEngine::sample_finish().
|
private |
Variance of the target function.
Definition at line 84 of file DescentEngine.h.
Referenced by DescentEngine::prepareStorage(), and DescentEngine::sample_finish().
|
private |
Vector for storing step sizes from previous optimization step.
Definition at line 181 of file DescentEngine.h.
Referenced by DescentEngine::updateParameters().
|
private |
a history of target function denominator times the |value/guiding|^2 ratios for one iteration
Definition at line 135 of file DescentEngine.h.
Referenced by DescentEngine::sample_finish().
|
private |
Definition at line 193 of file DescentEngine.h.
Referenced by DescentEngine::processXML(), DescentEngine::setStepSize(), and DescentEngine::updateParameters().
|
private |
Step sizes for different types of parameters.
Definition at line 192 of file DescentEngine.h.
Referenced by DescentEngine::processXML(), DescentEngine::setStepSize(), and DescentEngine::updateParameters().
|
private |
a history of target function numerator times the |value/guiding|^2 ratios for one iteration
Definition at line 125 of file DescentEngine.h.
Referenced by DescentEngine::sample_finish().
|
private |
history of sampled |value/guiding|^2 ratios for one iteration
Definition at line 89 of file DescentEngine.h.
Referenced by DescentEngine::sample_finish().
|
private |
history of sampled configuration weights for one iteration
Definition at line 99 of file DescentEngine.h.
Referenced by DescentEngine::sample_finish().
|
private |
Total sum of weights.
Definition at line 56 of file DescentEngine.h.
Referenced by DescentEngine::mpi_unbiased_ratio_of_means(), DescentEngine::prepareStorage(), and DescentEngine::sample_finish().