ergo
|
#include <SCF_general.h>
Public Member Functions | |
void | do_SCF_iterations () |
void | get_overlap_matrix (symmMatrix &S) |
void | get_invCholFactor_matrix (triangMatrix &invCholFactor_) |
void | get_H_core_matrix (symmMatrix &H_core) |
void | get_energy (ergo_real &E, ergo_real &E_nuclear) |
Protected Member Functions | |
SCF_general (const Molecule &molecule_, const Molecule &extraCharges_, const BasisInfoStruct &basisInfo_, const IntegralInfo &integralInfo_, const char *guessDmatFileName_, const JK::Params &J_K_params_, const Dft::GridParams &gridParams_, const SCF::Options &scfopts, const SCF::MatOptions &matOpts, ergo_real threshold_integrals_1el_input) | |
virtual | ~SCF_general () |
ergo_real | GetEuclideanNormOfMatrix (const symmMatrix &A) |
virtual void | initialize_matrices ()=0 |
virtual void | check_params ()=0 |
virtual void | get_starting_guess_density ()=0 |
virtual void | initialize_homo_lumo_limits ()=0 |
virtual void | write_matrices_to_file ()=0 |
virtual void | get_2e_part_and_energy ()=0 |
virtual void | output_sparsity_S_F_D (SCF_statistics &stats)=0 |
virtual void | calculate_energy ()=0 |
virtual void | get_FDSminusSDF ()=0 |
virtual void | get_error_measure ()=0 |
virtual void | add_to_DIIS_list ()=0 |
virtual void | update_best_fock_so_far ()=0 |
virtual void | combine_old_fock_matrices (ergo_real stepLength)=0 |
virtual void | use_diis_to_get_new_fock_matrix ()=0 |
virtual void | clear_diis_list ()=0 |
virtual void | clear_error_matrices ()=0 |
virtual void | save_current_fock_as_fprev ()=0 |
virtual void | get_new_density_matrix ()=0 |
virtual void | write_density_to_file ()=0 |
virtual void | save_final_potential ()=0 |
virtual void | add_random_disturbance_to_starting_guess ()=0 |
virtual void | output_expected_values_pos_operator ()=0 |
virtual void | output_density_images ()=0 |
virtual void | write_diag_dens_to_file ()=0 |
virtual void | report_final_results ()=0 |
virtual void | save_density_as_prevdens ()=0 |
virtual void | update_subspace_diff ()=0 |
virtual void | disturb_fock_matrix (ergo_real subspaceError)=0 |
virtual void | disturb_dens_matrix (ergo_real subspaceError)=0 |
virtual void | do_spin_flip (int atomCount)=0 |
virtual void | disturb_dens_matrix_exact (ergo_real subspaceError)=0 |
virtual void | save_full_matrices_for_matlab ()=0 |
virtual void | report_density_difference ()=0 |
virtual void | create_mtx_files_F (int const scfIter)=0 |
virtual void | create_mtx_files_D (int const scfIter)=0 |
virtual void | create_eigenvectors_files () const =0 |
virtual void | create_gabedit_file () const =0 |
virtual void | compute_dipole_moment ()=0 |
virtual void | do_mulliken_pop_stuff ()=0 |
virtual void | compute_gradient_fixeddens ()=0 |
|
protected |
References JK::ExchWeights::alpha, basisInfo, JK::ExchWeights::beta, SCF::Options::box_size_for_V_and_T, SCF::Options::calculation_identifier, CAM_params, SCF::Options::cht_blocksize, SCF::Options::cht_leavesSizeMax, compute_h_core_matrix_simple_dense(), compute_h_core_matrix_sparse(), compute_overlap_matrix_sparse(), JK::ExchWeights::computeRangeSeparatedExchange, SCF::Options::create_2el_integral_m_file, SCF::Options::create_basis_func_coord_file, SCF::Options::create_mtx_file_H_core, SCF::Options::create_mtx_file_S, SCF::Options::create_mtx_files_dipole, SCF::Options::create_mtx_files_S_and_quit, create_mtx_files_with_different_orderings(), DensFromFock, do_output(), do_output_time(), SCF::Options::electric_field, SCF::Options::electronic_temperature, electronicEntropyTerm, energy, energy_2el, energy_2el_core, energy_2el_valence, energy_of_valence, energy_reference, mat::MatrixGeneral< Treal, Tmatrix >::eucl_thresh(), extraCharges, SCF::Options::gap_expected_lower_bound, get_eucl_norm_try_different_acc(), get_hf_weight_and_cam_params(), get_host_name(), get_machine_epsilon(), GetDensFromFock::get_use_purification(), get_working_directory(), Molecule::getExtremeInternuclearDistancesQuadratic(), Molecule::getNoOfAtoms(), Molecule::getNuclearElectricFieldEnergy(), Molecule::getNumberOfElectrons(), H_core_Matrix, integralInfo, invCholFactor, invCholFactor_euclnorm, SCF::MatOptions::inversePermutationHML, LOG_AREA_SCF, LOG_CAT_ERROR, LOG_CAT_INFO, LOG_CAT_WARNING, matOpts, SCF::Options::method_and_basis_set, molecule, JK::ExchWeights::mu, SCF::Options::no_of_threads_for_V, BasisInfoStruct::noOfBasisFuncs, noOfElectrons, nuclearEnergy, output_current_memory_usage(), SCF::Options::output_homo_and_lumo_eigenvectors, output_sparsity_symm(), output_sparsity_triang(), SCF::MatOptions::permutationHML, Util::TimeMeter::print(), SCF::Options::puri_eig_acc_factor_for_guess, SCF::Options::purification_create_m_files, SCF::Options::purification_eigvalue_err_limit, SCF::Options::purification_ignore_failure, SCF::Options::purification_maxmul, SCF::Options::purification_stop_crit_norm, SCF::Options::purification_subspace_err_limit, SCF::Options::purification_truncation_norm, SCF::Options::purification_use_rand_perturbation_for_alleigsint, SCF::Options::purification_with_acceleration, mat::MatrixBase< Treal, Tmatrix >::resetSizesAndBlocks(), mat::right, host_name_struct::s, working_directory_struct::s, S_symm, SCF::Options::save_permuted_F_matrix_in_bin, save_symmetric_matrix(), scfopts, GetDensFromFock::set_cht_matrix_params(), GetDensFromFock::set_diagonalization_params(), GetDensFromFock::set_gap_expected_lower_bound(), GetDensFromFock::set_general_params(), GetDensFromFock::set_invCholFactor(), GetDensFromFock::set_output_homo_and_lumo_eigenvectors(), GetDensFromFock::set_purification_create_m_files(), GetDensFromFock::set_purification_ignore_failure(), GetDensFromFock::set_purification_limits(), GetDensFromFock::set_purification_maxmul(), GetDensFromFock::set_purification_use_rand_perturbation_for_alleigsint(), GetDensFromFock::set_save_permuted_F_matrix_in_bin(), GetDensFromFock::set_stopCriterionNormPurification(), GetDensFromFock::set_store_all_eigenvalues_to_file(), GetDensFromFock::set_truncationNormPurification(), GetDensFromFock::set_use_acceleration(), GetDensFromFock::set_use_diag_on_error(), GetDensFromFock::set_use_diag_on_error_guess(), GetDensFromFock::set_use_diagonalization(), GetDensFromFock::set_use_new_stopping_criterion(), GetDensFromFock::set_use_purification(), SCF::MatOptions::size_block_info, SCF::Options::skip_H_core, SCF::MatOptions::sparse_threshold, SCF::Options::sparse_threshold_for_S, SCF::Options::sparse_threshold_for_Z, SCF::Options::store_all_eigenvalues_to_file, template_blas_sqrt(), SCF::MatOptions::threshold_inch, threshold_integrals_1el, mat::transpose(), UNIT_one_Angstrom, GetDensFromFock::unset_generate_figures(), GetDensFromFock::unset_output_homo_and_lumo_eigenvectors(), GetDensFromFock::unset_purification_create_m_files(), GetDensFromFock::unset_purification_ignore_failure(), GetDensFromFock::unset_purification_use_rand_perturbation_for_alleigsint(), GetDensFromFock::unset_save_permuted_F_matrix_in_bin(), GetDensFromFock::unset_store_all_eigenvalues_to_file(), GetDensFromFock::unset_use_acceleration(), GetDensFromFock::unset_use_diag_on_error(), GetDensFromFock::unset_use_diag_on_error_guess(), GetDensFromFock::unset_use_diagonalization(), GetDensFromFock::unset_use_new_stopping_criterion(), GetDensFromFock::unset_use_purification(), SCF::Options::use_dft, SCF::Options::use_diag_on_error, SCF::Options::use_diag_on_error_guess, SCF::Options::use_diagonalization, SCF::Options::use_new_stopping_criterion, SCF::Options::use_simple_dense_H_core, Vector3D::v, VERSION, write_2el_integral_m_file(), write_basis_func_coord_file(), write_matrix_in_matrix_market_format(), and SCF::Options::write_overlap_matrix.
|
protectedvirtual |
References curr_cycle_stats.
|
protectedpure virtual |
Implemented in SCF_restricted, and SCF_unrestricted.
Referenced by do_SCF_iterations().
|
protectedpure virtual |
Implemented in SCF_restricted, and SCF_unrestricted.
Referenced by do_SCF_iterations().
|
protectedpure virtual |
Implemented in SCF_restricted, and SCF_unrestricted.
Referenced by do_SCF_iterations().
|
protectedpure virtual |
Implemented in SCF_restricted, and SCF_unrestricted.
Referenced by do_SCF_iterations().
|
protectedpure virtual |
Implemented in SCF_restricted, and SCF_unrestricted.
Referenced by do_SCF_iterations().
|
protectedpure virtual |
Implemented in SCF_restricted, and SCF_unrestricted.
Referenced by do_SCF_iterations().
|
protectedpure virtual |
Implemented in SCF_restricted, and SCF_unrestricted.
Referenced by do_SCF_iterations().
|
protectedpure virtual |
Implemented in SCF_restricted, and SCF_unrestricted.
Referenced by do_SCF_iterations().
|
protectedpure virtual |
Implemented in SCF_restricted, and SCF_unrestricted.
Referenced by do_SCF_iterations().
|
protectedpure virtual |
Implemented in SCF_restricted, and SCF_unrestricted.
Referenced by do_SCF_iterations().
|
protectedpure virtual |
Implemented in SCF_restricted, and SCF_unrestricted.
Referenced by do_SCF_iterations().
|
protectedpure virtual |
Implemented in SCF_restricted, and SCF_unrestricted.
Referenced by do_SCF_iterations().
|
protectedpure virtual |
Implemented in SCF_restricted, and SCF_unrestricted.
Referenced by do_SCF_iterations().
|
protectedpure virtual |
Implemented in SCF_restricted, and SCF_unrestricted.
|
protectedpure virtual |
Implemented in SCF_restricted, and SCF_unrestricted.
Referenced by do_SCF_iterations().
|
protectedpure virtual |
Implemented in SCF_restricted, and SCF_unrestricted.
|
protectedpure virtual |
Implemented in SCF_restricted, and SCF_unrestricted.
Referenced by do_SCF_iterations().
void SCF_general::do_SCF_iterations | ( | ) |
References add_random_disturbance_to_starting_guess(), add_to_DIIS_list(), SCF_statistics::add_value(), basisInfo, SCF::Options::break_on_energy_increase, calculate_energy(), check_params(), clear_diis_list(), clear_error_matrices(), combine_old_fock_matrices(), SCF::Options::compute_core_density, compute_dipole_moment(), SCF::Options::compute_gradient_fixeddens, compute_gradient_fixeddens(), create_eigenvectors_files(), create_gabedit_file(), SCF::Options::create_mtx_files_D, create_mtx_files_D(), SCF::Options::create_mtx_files_F, create_mtx_files_F(), curr_cycle_stats, curr_subspace_diff, DIIS, disturb_dens_matrix_exact(), do_mulliken_pop_stuff(), do_output(), do_output_time(), do_spin_flip(), SCF::Options::electronic_temperature, electronicEntropyTerm, energy, energy_2el, energy_of_valence, energy_reference, SCF::Options::error_maxabs_for_diis, errorMeasure, get_2e_part_and_energy(), get_error_measure(), get_FDSminusSDF(), get_memory_usage_by_procfile(), get_new_density_matrix(), get_starting_guess_density(), DIISManager::GetNoOfIters(), mat::AllocatorManager< Treal >::getStatistics(), DIISManager::Initialize(), initialize_homo_lumo_limits(), initialize_matrices(), mat::AllocatorManager< Treal >::instance(), J_K_params, LOG_AREA_SCF, LOG_CAT_INFO, LOG_CAT_RESULTS, matOpts, SCF::Options::max_no_of_diis_matrices, SCF::Options::max_number_of_iterations, SCF::Options::max_restart_count, SCF::Options::min_number_of_iterations, SCF::Options::no_of_careful_first_scf_steps, SCF::Options::no_of_impr_req_for_diis, BasisInfoStruct::noOfBasisFuncs, nuclearEnergy, output_current_memory_usage(), SCF::Options::output_density_at_every_step, SCF::Options::output_density_images, output_density_images(), SCF::Options::output_density_images_only, SCF::Options::output_expected_values_pos_operator, output_expected_values_pos_operator(), SCF::Options::output_homo_and_lumo_eigenvectors, SCF_statistics::output_mfile(), SCF::Options::output_mulliken_pop, output_sparsity_S_F_D(), SCF::Options::output_statistics_mfiles, Util::TimeMeter::print(), report_density_difference(), report_final_results(), save_current_fock_as_fprev(), save_density_as_prevdens(), SCF::Options::save_final_potential, save_final_potential(), SCF::Options::save_full_matrices_for_matlab, save_full_matrices_for_matlab(), SCF_step, scfopts, SCF::MatOptions::sparse_matrix_block_size, SCF::Options::spin_flip_atom_count, SCF_statistics::start_timer(), SCF::Options::starting_guess_disturbance, SCF::Options::step_length_giveup, SCF::Options::step_length_start, SCF_statistics::stop_timer(), SCF::Options::subspace_factor_dens, JK::Params::threshold_J, JK::Params::threshold_K, UNIT_one_Kelvin, update_best_fock_so_far(), update_subspace_diff(), SCF::Options::use_artificial_subspace_disturbances, SCF::Options::use_diis_always, use_diis_to_get_new_fock_matrix(), SCF::Options::use_simple_starting_guess, write_density_to_file(), SCF::Options::write_diag_dens_to_file, write_diag_dens_to_file(), SCF::Options::write_guess_density_only, and write_matrices_to_file().
|
protectedpure virtual |
Implemented in SCF_restricted, and SCF_unrestricted.
Referenced by do_SCF_iterations().
|
protectedpure virtual |
Implemented in SCF_restricted, and SCF_unrestricted.
Referenced by do_SCF_iterations().
References energy, and nuclearEnergy.
|
protectedpure virtual |
Implemented in SCF_restricted, and SCF_unrestricted.
Referenced by do_SCF_iterations().
|
protectedpure virtual |
Implemented in SCF_restricted, and SCF_unrestricted.
Referenced by do_SCF_iterations().
void SCF_general::get_H_core_matrix | ( | symmMatrix & | H_core | ) |
References H_core_Matrix.
void SCF_general::get_invCholFactor_matrix | ( | triangMatrix & | invCholFactor_ | ) |
References invCholFactor.
|
protectedpure virtual |
Implemented in SCF_restricted, and SCF_unrestricted.
Referenced by do_SCF_iterations().
void SCF_general::get_overlap_matrix | ( | symmMatrix & | S | ) |
References S_symm.
Referenced by SCF_unrestricted::get_2e_part_and_energy().
|
protectedpure virtual |
Implemented in SCF_restricted, and SCF_unrestricted.
Referenced by do_SCF_iterations().
|
protected |
References A, and template_blas_sqrt().
Referenced by SCF_unrestricted::report_density_difference(), and SCF_restricted::report_density_difference().
|
protectedpure virtual |
Implemented in SCF_restricted, and SCF_unrestricted.
Referenced by do_SCF_iterations().
|
protectedpure virtual |
Implemented in SCF_restricted, and SCF_unrestricted.
Referenced by do_SCF_iterations().
|
protectedpure virtual |
Implemented in SCF_restricted, and SCF_unrestricted.
Referenced by do_SCF_iterations().
|
protectedpure virtual |
Implemented in SCF_restricted, and SCF_unrestricted.
Referenced by do_SCF_iterations().
|
protectedpure virtual |
Implemented in SCF_restricted, and SCF_unrestricted.
Referenced by do_SCF_iterations().
|
protectedpure virtual |
Implemented in SCF_restricted, and SCF_unrestricted.
Referenced by do_SCF_iterations().
|
protectedpure virtual |
Implemented in SCF_restricted, and SCF_unrestricted.
Referenced by do_SCF_iterations().
|
protectedpure virtual |
Implemented in SCF_restricted, and SCF_unrestricted.
Referenced by do_SCF_iterations().
|
protectedpure virtual |
Implemented in SCF_restricted, and SCF_unrestricted.
Referenced by do_SCF_iterations().
|
protectedpure virtual |
Implemented in SCF_restricted, and SCF_unrestricted.
Referenced by do_SCF_iterations().
|
protectedpure virtual |
Implemented in SCF_restricted, and SCF_unrestricted.
Referenced by do_SCF_iterations().
|
protectedpure virtual |
Implemented in SCF_restricted, and SCF_unrestricted.
Referenced by do_SCF_iterations().
|
protectedpure virtual |
Implemented in SCF_restricted, and SCF_unrestricted.
Referenced by do_SCF_iterations().
|
protectedpure virtual |
Implemented in SCF_restricted, and SCF_unrestricted.
Referenced by do_SCF_iterations().
|
protectedpure virtual |
Implemented in SCF_restricted, and SCF_unrestricted.
Referenced by do_SCF_iterations().
|
protectedpure virtual |
Implemented in SCF_restricted, and SCF_unrestricted.
Referenced by do_SCF_iterations().
|
protectedpure virtual |
Implemented in SCF_restricted, and SCF_unrestricted.
Referenced by do_SCF_iterations().
|
protected |
Referenced by SCF_unrestricted::add_random_disturbance_to_starting_guess(), SCF_restricted::add_random_disturbance_to_starting_guess(), SCF_unrestricted::compute_dipole_moment(), SCF_restricted::compute_dipole_moment(), SCF_restricted::compute_gradient_fixeddens(), SCF_unrestricted::create_eigvec_file(), SCF_restricted::create_eigvec_file(), SCF_unrestricted::create_gabedit_file(), SCF_restricted::create_gabedit_file(), SCF_unrestricted::do_mulliken_pop_stuff(), SCF_restricted::do_mulliken_pop_stuff(), do_SCF_iterations(), SCF_unrestricted::do_spin_flip(), SCF_unrestricted::get_2e_part_and_energy(), SCF_restricted::get_2e_part_and_energy(), SCF_restricted::get_expected_values_pos_operator(), SCF_unrestricted::get_FDSminusSDF(), SCF_restricted::get_FDSminusSDF(), SCF_restricted::get_new_density_matrix(), SCF_unrestricted::get_starting_guess_density(), SCF_restricted::get_starting_guess_density(), SCF_unrestricted::output_density_images(), SCF_restricted::output_density_images(), SCF_restricted::output_density_images_orbital(), SCF_unrestricted::output_sparsity_S_F_D(), SCF_restricted::output_sparsity_S_F_D(), SCF_restricted::save_final_potential(), SCF_restricted::save_full_matrices_for_matlab(), SCF_general(), SCF_unrestricted::write_density_to_file(), SCF_restricted::write_density_to_file(), SCF_unrestricted::write_diag_dens_to_file(), and SCF_restricted::write_diag_dens_to_file().
|
protected |
|
protected |
|
protected |
Referenced by do_SCF_iterations(), and SCF_restricted::update_subspace_diff().
|
protected |
Referenced by SCF_restricted::disturb_dens_matrix_exact_try(), SCF_restricted::disturb_fock_matrix(), SCF_unrestricted::get_new_density_matrix(), SCF_restricted::get_new_density_matrix(), SCF_unrestricted::get_starting_guess_density(), SCF_restricted::get_starting_guess_density(), SCF_general(), SCF_restricted::SCF_restricted(), and SCF_unrestricted::SCF_unrestricted().
|
protected |
Referenced by SCF_unrestricted::add_to_DIIS_list(), SCF_restricted::add_to_DIIS_list(), SCF_unrestricted::clear_diis_list(), SCF_restricted::clear_diis_list(), do_SCF_iterations(), SCF_restricted::SCF_restricted(), SCF_unrestricted::SCF_unrestricted(), SCF_unrestricted::use_diis_to_get_new_fock_matrix(), SCF_restricted::use_diis_to_get_new_fock_matrix(), SCF_restricted::~SCF_restricted(), and SCF_unrestricted::~SCF_unrestricted().
|
protected |
|
protected |
|
protected |
|
protected |
Referenced by SCF_restricted::calculate_energy(), SCF_restricted::get_2e_part_and_energy(), and SCF_general().
|
protected |
Referenced by SCF_restricted::calculate_energy(), SCF_restricted::get_2e_part_and_energy(), and SCF_general().
|
protected |
Referenced by SCF_restricted::calculate_energy(), do_SCF_iterations(), and SCF_general().
|
protected |
Referenced by SCF_restricted::calculate_energy(), do_SCF_iterations(), and SCF_general().
|
protected |
Referenced by do_SCF_iterations(), SCF_unrestricted::get_error_measure(), and SCF_restricted::get_error_measure().
|
protected |
Referenced by SCF_general().
|
protected |
Referenced by SCF_unrestricted::get_2e_part_and_energy(), and SCF_restricted::get_2e_part_and_energy().
|
protected |
|
protected |
Referenced by SCF_unrestricted::calculate_energy(), SCF_restricted::calculate_energy(), SCF_unrestricted::get_2e_part_and_energy(), SCF_restricted::get_2e_part_and_energy(), get_H_core_matrix(), SCF_unrestricted::get_starting_guess_density(), SCF_restricted::get_starting_guess_density(), and SCF_general().
|
protected |
Referenced by SCF_restricted::compute_gradient_fixeddens(), SCF_unrestricted::create_gabedit_file(), SCF_restricted::create_gabedit_file(), SCF_unrestricted::get_2e_part_and_energy(), SCF_restricted::get_2e_part_and_energy(), SCF_unrestricted::get_starting_guess_density(), SCF_restricted::get_starting_guess_density(), and SCF_general().
|
protected |
|
protected |
Referenced by SCF_general().
|
protected |
|
protected |
Referenced by SCF_unrestricted::add_random_disturbance_to_starting_guess(), SCF_restricted::add_random_disturbance_to_starting_guess(), SCF_unrestricted::compute_dipole_moment(), SCF_restricted::compute_dipole_moment(), SCF_restricted::compute_gradient_fixeddens(), SCF_unrestricted::create_eigvec_file(), SCF_restricted::create_eigvec_file(), SCF_unrestricted::create_gabedit_file(), SCF_restricted::create_gabedit_file(), SCF_unrestricted::create_mtx_files_D(), SCF_restricted::create_mtx_files_D(), SCF_unrestricted::create_mtx_files_F(), SCF_restricted::create_mtx_files_F(), SCF_restricted::disturb_dens_matrix(), SCF_restricted::disturb_dens_matrix_exact(), SCF_restricted::disturb_dens_matrix_exact_try(), SCF_restricted::disturb_fock_matrix(), SCF_unrestricted::do_mulliken_pop_stuff(), SCF_restricted::do_mulliken_pop_stuff(), do_SCF_iterations(), SCF_unrestricted::do_spin_flip(), SCF_unrestricted::get_2e_part_and_energy(), SCF_restricted::get_2e_part_and_energy(), SCF_restricted::get_expected_values_pos_operator(), SCF_unrestricted::get_FDSminusSDF(), SCF_restricted::get_FDSminusSDF(), SCF_restricted::get_non_ort_err_mat_normalized_in_ort_basis(), SCF_unrestricted::get_S2(), SCF_unrestricted::get_starting_guess_density(), SCF_restricted::get_starting_guess_density(), SCF_unrestricted::initialize_matrices(), SCF_restricted::initialize_matrices(), SCF_unrestricted::output_density_images(), SCF_restricted::output_density_images(), SCF_restricted::output_density_images_orbital(), SCF_restricted::save_final_potential(), SCF_restricted::save_full_matrices_for_matlab(), SCF_general(), SCF_unrestricted::use_diis_to_get_new_fock_matrix(), SCF_unrestricted::write_density_to_file(), SCF_restricted::write_density_to_file(), SCF_unrestricted::write_diag_dens_to_file(), and SCF_restricted::write_diag_dens_to_file().
|
protected |
Referenced by SCF_unrestricted::compute_dipole_moment(), SCF_restricted::compute_dipole_moment(), SCF_restricted::compute_gradient_fixeddens(), SCF_unrestricted::create_gabedit_file(), SCF_restricted::create_gabedit_file(), SCF_unrestricted::do_mulliken_pop_stuff(), SCF_restricted::do_mulliken_pop_stuff(), SCF_unrestricted::do_spin_flip(), SCF_unrestricted::get_2e_part_and_energy(), SCF_restricted::get_2e_part_and_energy(), SCF_restricted::get_expected_values_pos_operator(), SCF_unrestricted::output_density_images(), SCF_restricted::output_density_images(), SCF_restricted::output_density_images_orbital(), and SCF_general().
|
protected |
|
protected |
|
protected |
Referenced by SCF_unrestricted::do_mulliken_pop_stuff(), SCF_restricted::do_mulliken_pop_stuff(), SCF_unrestricted::do_spin_flip(), SCF_unrestricted::get_FDSminusSDF(), SCF_restricted::get_FDSminusSDF(), SCF_unrestricted::get_new_density_matrix(), SCF_restricted::get_new_density_matrix(), get_overlap_matrix(), SCF_unrestricted::get_S2(), SCF_unrestricted::get_starting_guess_density(), SCF_restricted::get_starting_guess_density(), SCF_unrestricted::output_sparsity_S_F_D(), SCF_restricted::output_sparsity_S_F_D(), SCF_restricted::save_full_matrices_for_matlab(), SCF_general(), and SCF_restricted::transform_with_S().
|
protected |
|
protected |
Referenced by SCF_unrestricted::add_random_disturbance_to_starting_guess(), SCF_restricted::add_random_disturbance_to_starting_guess(), SCF_restricted::calculate_energy(), SCF_restricted::compute_gradient_fixeddens(), SCF_unrestricted::create_mtx_files_D(), SCF_restricted::create_mtx_files_D(), SCF_unrestricted::create_mtx_files_F(), SCF_restricted::create_mtx_files_F(), do_SCF_iterations(), SCF_unrestricted::get_2e_part_and_energy(), SCF_restricted::get_2e_part_and_energy(), SCF_unrestricted::get_new_density_matrix(), SCF_restricted::get_new_density_matrix(), SCF_unrestricted::get_starting_guess_density(), SCF_restricted::get_starting_guess_density(), SCF_unrestricted::output_density_images(), SCF_restricted::output_density_images(), SCF_restricted::output_density_images_orbital(), SCF_restricted::report_density_difference(), SCF_general(), and SCF_restricted::write_density_to_file().
|
protected |
Referenced by SCF_restricted::compute_gradient_fixeddens(), and SCF_general().