MADNESS
0.10.1
|
#include <TDHF.h>
Classes | |
struct | TDHFParameters |
the TDHF parameter class More... | |
Public Member Functions | |
TDHF (World &world, const commandlineparser &parser) | |
ctor with command line parser, constructs SCF and Nemo objects on-the-fly, and delegates further More... | |
TDHF (World &world, const commandlineparser &parser, std::shared_ptr< Nemo > nemo) | |
ctor with command line parser, constructs SCF and Nemo objects on-the-fly, and delegates further More... | |
virtual | ~TDHF () |
void | analyze (const std::vector< CC_vecfunction > &x) const |
analyze the root: oscillator strength and contributions from occupied orbitals More... | |
void | check_consistency () const |
check consistency of the input parameters More... | |
MolecularOrbitals< double, 3 > | enforce_core_valence_separation (const Tensor< double > &fmat) const |
std::shared_ptr< SCF > | get_calc () const |
CalculationParameters & | get_calcparam () const |
std::vector< CC_vecfunction > | get_converged_roots () const |
std::shared_ptr< Nemo > | get_nemo () const |
TDHFParameters | get_parameters () const |
std::shared_ptr< NemoBase > | get_reference () const |
projector_irrep | get_symmetry_projector () const |
void | initialize () |
void | initialize (std::vector< CC_vecfunction > &start) const |
Initialize the CIS functions. More... | |
std::string | name () const |
void | plot (const vector_real_function_3d &vf, const std::string &name) const |
plot planes and cubes More... | |
void | prepare_calculation () |
compute non-trivial prerequisites for the calculation More... | |
void | print_frozen_orbitals () const |
void | print_xfunctions (const std::vector< CC_vecfunction > &f, const std::string message) const |
print information More... | |
virtual bool | selftest () |
void | set_reference (std::shared_ptr< NemoBase > reference) |
sets the reference wave function (nemo or oep) More... | |
std::vector< CC_vecfunction > | solve_cis () const |
Solve the CIS equations. More... | |
std::vector< CC_vecfunction > | sort_xfunctions (std::vector< CC_vecfunction > x) const |
sort the xfunctions according to their excitation energy and name the excitation energies accordingly More... | |
void | symmetrize (std::vector< CC_vecfunction > &v) const |
Static Public Member Functions | |
static void | help () |
static void | print_parameters () |
static int | test (World &world, commandlineparser &parser) |
Private Member Functions | |
vector_real_function_3d | apply_excitation_operators (const vector_real_function_3d &seed, const bool &use_trigo=true) const |
std::vector< vector_real_function_3d > | apply_G (std::vector< CC_vecfunction > &x, std::vector< vector_real_function_3d > &V) const |
vector_real_function_3d | canonicalize (const vector_real_function_3d &v, Tensor< double > &veps) const |
canonicalize a set of orbitals (here the virtuals for the guess) More... | |
std::string | filename_for_roots (const int ex) const |
const vector_real_function_3d | get_active_mo_bra () const |
const vector_real_function_3d | get_active_mo_ket () const |
double | get_orbital_energy (const size_t i) const |
vector_real_function_3d | get_tda_potential (const CC_vecfunction &x) const |
Make the TDA potential for a single excitation vector. More... | |
bool | iterate_cis_final_vectors (std::vector< CC_vecfunction > &x) const |
bool | iterate_cis_guess_vectors (std::vector< CC_vecfunction > &x) const |
bool | iterate_vectors (std::vector< CC_vecfunction > &x, const std::vector< CC_vecfunction > &y, bool iterate_y, const double dconv, const double econv, const double iter, const bool kain) const |
vector_real_function_3d | make_bra (const CC_vecfunction &ket) const |
convenience More... | |
real_function_3d | make_bra (const real_function_3d &ket) const |
vector_real_function_3d | make_bra (const vector_real_function_3d &ket) const |
maybe move this into nuclear_correlation class ? More... | |
Tensor< double > | make_cis_matrix (const vector_real_function_3d &virtuals, const Tensor< double > &veps) const |
compute the CIS matrix for a given set of virtuals More... | |
vector< CC_vecfunction > | make_guess_from_initial_diagonalization () const |
make the initial guess by explicitly diagonalizing a CIS matrix with virtuals from the make_virtuals routine More... | |
CC_vecfunction | make_mo_bra (const std::vector< Function< double, 3 >> &amo) const |
Helper function to initialize the const mo_bra and ket elements. More... | |
CC_vecfunction | make_mo_ket (const std::vector< Function< double, 3 >> &amo) const |
Tensor< double > | make_overlap_matrix (const std::vector< CC_vecfunction > &x) const |
Tensor< double > | make_perturbed_fock_matrix (const std::vector< CC_vecfunction > &x, const std::vector< vector_real_function_3d > &V) const |
std::vector< vector_real_function_3d > | make_potentials (const std::vector< CC_vecfunction > &x) const |
std::vector< vector_real_function_3d > | make_tdhf_potentials (std::vector< CC_vecfunction > &x, const std::vector< CC_vecfunction > &y) const |
Make the TDHF potential (not ready) More... | |
vector_real_function_3d | make_virtuals () const |
Create a set of virtual orbitals for the initial guess. More... | |
void | orthonormalize (std::vector< CC_vecfunction > &x, std::vector< vector_real_function_3d > &V) const |
double | oscillator_strength_length (const CC_vecfunction &x) const |
compute the oscillator strength in the length representation More... | |
double | oscillator_strength_velocity (const CC_vecfunction &x) const |
compute the oscillator strength in the velocity representation More... | |
std::vector< CC_vecfunction > | solve_cis (std::vector< CC_vecfunction > &start) const |
void | solve_tdhf (std::vector< CC_vecfunction > &guess) const |
Solve TDHF equations (not ready) More... | |
std::vector< CC_vecfunction > | transform (const std::vector< CC_vecfunction > &x, const madness::Tensor< double > U) const |
Interface to the SCF.h fock_transform function. More... | |
std::vector< vector_real_function_3d > | transform (const std::vector< vector_real_function_3d > &x, const madness::Tensor< double > U) const |
Private Attributes | |
std::vector< CC_vecfunction > | converged_roots |
converged roots More... | |
Tensor< double > | F_occ |
Fock matrix for occupied orbitals. More... | |
std::shared_ptr< CCConvolutionOperator< double, 3 > > | g12 |
std::vector< CC_vecfunction > | guess_roots |
stored guess roots roots to feed into the cycle, sorted backwards for easier pop_back calling More... | |
CC_vecfunction | mo_bra_ |
CC_vecfunction | mo_ket_ |
MO bra and ket. More... | |
CCMessenger | msg |
the messenger IO More... | |
TDHFParameters | parameters |
The TDHFParameters for the Calculations. More... | |
QProjector< double, 3 > | Q |
the Projector to the virtual space More... | |
std::shared_ptr< NemoBase > | reference_ |
The Nemo structure (convenience) More... | |
projector_irrep | symmetry_projector |
the symmetry projector More... | |
World & | world |
The MPI Communicator. More... | |
The TDHF class solves CIS/TDA equations and hopefully soon the full TDHF/TDDFT equations
madness::TDHF::TDHF | ( | World & | world, |
const commandlineparser & | parser | ||
) |
madness::TDHF::TDHF | ( | World & | world, |
const commandlineparser & | parser, | ||
std::shared_ptr< Nemo > | nemo | ||
) |
ctor with command line parser, constructs SCF and Nemo objects on-the-fly, and delegates further
world | the world |
parser | the parser |
References madness::TDHF::TDHFParameters::do_oep(), get_calc(), initialize(), parameters, madness::TDHF::TDHFParameters::set_derived_values(), set_reference(), and world.
|
inlinevirtual |
void madness::TDHF::analyze | ( | const std::vector< CC_vecfunction > & | x | ) | const |
analyze the root: oscillator strength and contributions from occupied orbitals
analyze the root: oscillator strength and contributions from occ
References madness::dot(), madness::TDHF::TDHFParameters::freeze(), get_active_mo_bra(), get_active_mo_ket(), get_calc(), get_reference(), madness::constants::hartree_electron_volt_relationship, msg, madness::norm2s(), oscillator_strength_length(), oscillator_strength_velocity(), p(), param, parameters, InputParameters::prefix, madness::print(), madness::World::rank(), madness::save(), madness::Function< T, NDIM >::trace(), and world.
|
private |
multiply excitation operators defined in the parameters with the seed functions
[in] | the | seeds, define the function which are multiplied by the excitation operators |
[in] | use_trigo,if | false polynomials are used for excitation operators, else trigonometric functions (i.e. x^2y vs sin^2(x)*sin(y)) Trigonometric functions are prefered since they are bounded (no weird behaviour at the boundaries for large exponents) |
References madness::append(), madness::guessfactory::apply_polynomial_exop(), madness::guessfactory::apply_trigonometric_exop(), madness::guessfactory::compute_centroids(), madness::copy(), madness::TDHF::TDHFParameters::exops(), madness::WorldGopInterface::fence(), madness::World::gop, madness::TDHF::TDHFParameters::guess_excitation_operators(), madness::guessfactory::make_predefined_exop_strings(), msg, parameters, madness::CCTimer::print(), and world.
Referenced by make_virtuals().
|
private |
Apply the Greens function to a vector of vectorfunction with a given potential
[in] | x | the vector of vectorfunctions where G will be applied to |
[in] | V | the vector of potentials to the vectorfunctions, will be cleared afterwards (potentials are all potentials excpet the nuclear: 2J - K + Q(2pJ - pK) |
[out] | the | vectorfunctions after G has been applied the energy is assumed to be stored in the CC_vecfunctions member omega the wavefunction error is stored in the CC_vecfunctions member current_error |
References madness::apply(), madness::BSHOperatorPtr3D(), madness::TDHF::TDHFParameters::debug(), madness::WorldGopInterface::fence(), madness::TDHF::TDHFParameters::freeze(), get_calcparam(), get_orbital_energy(), get_reference(), get_tda_potential(), madness::World::gop, madness::CCTimer::info(), lo, MADNESS_ASSERT, msg, omega, madness::CCMessenger::output(), p(), parameters, Q, residual(), madness::RESPONSE, madness::scale(), shift, madness::sub(), madness::TDHF::TDHFParameters::thresh(), madness::type(), madness::UNDEFINED, V(), madness::CCMessenger::warning(), and world.
Referenced by iterate_vectors().
|
private |
canonicalize a set of orbitals (here the virtuals for the guess)
[out] | veps | orbital energies of the virtuals |
References madness::TDHF::TDHFParameters::debug(), F, get_calc(), get_reference(), make_bra(), madness::matrix_inner(), msg, parameters, madness::CCTimer::print(), madness::transform(), v, and world.
Referenced by make_guess_from_initial_diagonalization().
void madness::TDHF::check_consistency | ( | ) | const |
check consistency of the input parameters
References get_symmetry_projector(), madness::projector_irrep::get_table(), madness::TDHF::TDHFParameters::irrep(), MADNESS_EXCEPTION, madness::charactertable::mullikan_, parameters, and madness::print().
Referenced by initialize().
MolecularOrbitals< double, 3 > madness::TDHF::enforce_core_valence_separation | ( | const Tensor< double > & | fmat | ) | const |
References madness::Localizer::check_core_valence_separation(), get_calc(), get_calcparam(), madness::MolecularOrbitals< T, NDIM >::get_localize_sets(), madness::MolecularOrbitals< T, NDIM >::get_mos(), get_reference(), MADNESS_CHECK, make_bra(), madness::print(), madness::MolecularOrbitals< T, NDIM >::recompute_localize_sets(), madness::Localizer::separate_core_valence(), madness::Localizer::set_enforce_core_valence_separation(), madness::Localizer::set_method(), madness::Localizer::set_metric(), and world.
Referenced by prepare_calculation().
|
inlineprivate |
References get_calcparam(), and madness::CalculationParameters::prefix().
Referenced by iterate_vectors(), and solve_cis().
|
inlineprivate |
References madness::TDHF::TDHFParameters::freeze(), mo_bra_, mo_ket_, parameters, and madness::CC_vecfunction::size().
Referenced by analyze(), get_tda_potential(), make_cis_matrix(), oscillator_strength_length(), and prepare_calculation().
|
inlineprivate |
References madness::TDHF::TDHFParameters::freeze(), mo_ket_, parameters, and madness::CC_vecfunction::size().
Referenced by analyze(), get_tda_potential(), make_cis_matrix(), make_guess_from_initial_diagonalization(), make_virtuals(), oscillator_strength_velocity(), prepare_calculation(), and symmetrize().
|
inline |
References MADNESS_EXCEPTION, and reference_.
Referenced by TDHF(), analyze(), canonicalize(), enforce_core_valence_separation(), get_tda_potential(), main(), make_cis_matrix(), make_guess_from_initial_diagonalization(), make_perturbed_fock_matrix(), make_virtuals(), orthonormalize(), plot(), prepare_calculation(), and print_frozen_orbitals().
|
inline |
References MADNESS_EXCEPTION, and reference_.
Referenced by apply_G(), enforce_core_valence_separation(), filename_for_roots(), get_tda_potential(), initialize(), main(), make_cis_matrix(), prepare_calculation(), and test().
|
inline |
References converged_roots.
|
inline |
References MADNESS_EXCEPTION, and reference_.
Referenced by get_tda_potential(), initialize(), prepare_calculation(), and symmetrize().
|
inlineprivate |
References MADNESS_EXCEPTION, and reference_.
Referenced by apply_G(), make_cis_matrix(), make_perturbed_fock_matrix(), make_virtuals(), and prepare_calculation().
|
inline |
References parameters.
Referenced by main().
|
inline |
|
inline |
References symmetry_projector.
Referenced by check_consistency().
|
private |
Make the TDA potential for a single excitation vector.
References madness::add(), madness::Coulomb< T, NDIM >::compute_potential(), madness::TDHF::TDHFParameters::debug(), madness::TDHF::TDHFParameters::do_oep(), F_occ, madness::CC_vecfunction::functions, get_active_mo_bra(), get_active_mo_ket(), get_calc(), get_calcparam(), get_nemo(), get_reference(), madness::CC_vecfunction::get_vecfunction(), madness::CCTimer::info(), k, MADNESS_EXCEPTION, mo_bra_, mo_ket_, madness::norm2(), parameters, madness::TDHF::TDHFParameters::plot(), madness::plot_plane(), madness::Coulomb< T, NDIM >::potential(), Q, madness::Fock< T, NDIM >::remove_operator(), madness::TDHF::TDHFParameters::response_kernel(), madness::scale(), madness::sub(), madness::transform(), madness::TDHF::TDHFParameters::triplet(), madness::truncate(), world, and xc.
Referenced by apply_G(), make_perturbed_fock_matrix(), and make_potentials().
|
inlinestatic |
References madness::print(), and madness::print_header2().
Referenced by main().
void madness::TDHF::initialize | ( | ) |
References check_consistency(), madness::CCMessenger::debug, madness::TDHF::TDHFParameters::debug(), g12, get_calcparam(), madness::TDHF::TDHFParameters::get_ccc_parameters(), get_nemo(), madness::FunctionDefaults< NDIM >::get_thresh(), lo, msg, madness::OT_G12, parameters, madness::CCMessenger::section(), madness::projector_irrep::set_lindep(), madness::projector_irrep::set_orthonormalize_irreps(), madness::projector_irrep::set_verbosity(), symmetry_projector, madness::TDHF::TDHFParameters::thresh(), madness::CCMessenger::warning(), and world.
Referenced by TDHF(), initialize(), and solve_cis().
void madness::TDHF::initialize | ( | std::vector< CC_vecfunction > & | start | ) | const |
Initialize the CIS functions.
[in |
References guess(), madness::TDHF::TDHFParameters::guess_excitations(), madness::TDHF::TDHFParameters::guess_maxiter(), initialize(), iterate_cis_guess_vectors(), MADNESS_EXCEPTION, make_guess_from_initial_diagonalization(), msg, madness::CCMessenger::output(), parameters, and madness::CCMessenger::subsection().
|
private |
iterate the final CIS vectors
[in,out] | x | on input the guess, on output the iterated guess see CC_Structures.h CCParameters class for convergence criteria |
References madness::TDHF::TDHFParameters::dconv(), madness::TDHF::TDHFParameters::econv(), iterate_vectors(), madness::TDHF::TDHFParameters::kain_subspace(), madness::TDHF::TDHFParameters::maxiter(), and parameters.
Referenced by solve_cis().
|
private |
iterate the CIS guess vectors
[in,out] | x | on input the guess, on output the iterated guess see CC_Structures.h CCParameters class for convergence criteria |
References madness::TDHF::TDHFParameters::guess_dconv(), madness::TDHF::TDHFParameters::guess_econv(), madness::TDHF::TDHFParameters::guess_maxiter(), iterate_vectors(), and parameters.
Referenced by initialize(), and solve_cis().
|
private |
General function to iterate vectors
[in,out] | x | the CIS (or TDHF x) functions |
[in,out] | the | TDHF y functions (empty for CIS) |
[in] | iterate_y,if | true the y equation for TDHF is iterated |
[in] | dconv | wavefunction convergence (for the vector norm of the vectorfunction) |
[in] | econv | Energy convergece |
[in] | iter | maximum number of iterations |
[in] | kain | use kain if true (kainsubspace is controlled over CCParameters class) |
References apply_G(), converged_roots, delta, std::distance(), filename_for_roots(), madness::TDHF::TDHFParameters::freeze(), guess_roots, madness::inner(), madness::TDHF::TDHFParameters::kain_subspace(), MADNESS_ASSERT, make_bra(), make_potentials(), make_tdhf_potentials(), msg, madness::TDHF::TDHFParameters::nexcitations(), madness::norm2(), madness::norm2s(), omega, orthonormalize(), madness::CCMessenger::output(), parameters, madness::TDHF::TDHFParameters::plot(), plot(), madness::CCTimer::print(), madness::timer::print(), print_xfunctions(), Q, sort_xfunctions(), madness::TDHF::TDHFParameters::store_potential(), madness::sub(), madness::CCMessenger::subsection(), symmetrize(), madness::TDHF::TDHFParameters::thresh(), timer(), madness::truncate(), madness::type(), V(), and world.
Referenced by iterate_cis_final_vectors(), and iterate_cis_guess_vectors().
|
inlineprivate |
convenience
References madness::CC_vecfunction::get_vecfunction().
Referenced by canonicalize(), enforce_core_valence_separation(), iterate_vectors(), make_bra(), make_cis_matrix(), make_guess_from_initial_diagonalization(), make_overlap_matrix(), make_perturbed_fock_matrix(), make_virtuals(), and prepare_calculation().
|
inlineprivate |
References make_bra(), and v.
|
inlineprivate |
maybe move this into nuclear_correlation class ?
References madness::TDHF::TDHFParameters::debug(), madness::CCTimer::info(), madness::mul(), parameters, reference_, and world.
|
private |
compute the CIS matrix for a given set of virtuals
[in] | virtuals | the virtual orbitals |
[in] | veps | the orbital energies of the virtuals |
References madness::_(), a, b, madness::TDHF::TDHFParameters::debug(), delta, madness::BaseTensor::dim(), madness::TDHF::TDHFParameters::do_oep(), F, madness::TDHF::TDHFParameters::freeze(), get_active_mo_bra(), get_active_mo_ket(), get_calc(), get_calcparam(), get_orbital_energy(), get_reference(), madness::CC_vecfunction::get_vecfunction(), madness::TDHF::TDHFParameters::guess_diag(), I, madness::CCTimer::info(), madness::inner(), make_bra(), madness::matrix_inner(), mo_bra_, mo_ket_, msg, parameters, madness::transpose(), world, xc, and madness::CalculationParameters::xc().
Referenced by make_guess_from_initial_diagonalization().
|
private |
make the initial guess by explicitly diagonalizing a CIS matrix with virtuals from the make_virtuals routine
References madness::_(), a, b, canonicalize(), madness::TDHF::TDHFParameters::debug(), madness::BaseTensor::dim(), madness::TDHF::TDHFParameters::freeze(), get_active_mo_ket(), get_calc(), get_reference(), madness::TDHF::TDHFParameters::guess_excitations(), I, madness::TDHF::TDHFParameters::irrep(), MADNESS_EXCEPTION, make_bra(), make_cis_matrix(), make_overlap_matrix(), make_virtuals(), madness::matrix_inner(), max, madness::Tensor< T >::min(), msg, madness::orthonormalize_rrcd(), parameters, madness::CCTimer::print(), madness::print(), madness::print_header1(), print_xfunctions(), R, madness::World::rank(), madness::projector_irrep::reduce(), reduced, madness::RESPONSE, madness::projector_irrep::set_lindep(), madness::projector_irrep::set_verbosity(), madness::BaseTensor::size(), madness::syev(), symmetry_projector, madness::TDHF::TDHFParameters::thresh(), madness::truncate(), madness::Localizer::undo_degenerate_rotations(), madness::CCMessenger::warning(), and world.
Referenced by initialize().
|
inlineprivate |
Helper function to initialize the const mo_bra and ket elements.
References get_reference(), madness::HOLE, parameters, madness::reconstruct(), madness::set_thresh(), madness::TDHF::TDHFParameters::thresh(), madness::truncate(), and world.
Referenced by prepare_calculation().
|
inlineprivate |
References madness::copy(), madness::HOLE, parameters, madness::reconstruct(), madness::set_thresh(), madness::TDHF::TDHFParameters::thresh(), madness::truncate(), and world.
Referenced by prepare_calculation().
|
private |
References madness::TDHF::TDHFParameters::debug(), madness::CCTimer::info(), madness::inner(), k, make_bra(), msg, parameters, and world.
Referenced by make_guess_from_initial_diagonalization(), and orthonormalize().
|
private |
Calculate the perturbed fock matrix for a given vector of excitations
[in] | input | the excitations |
[in] | input | the potentials, if empty the potentials will be recalculated but NOT stored |
References madness::apply(), madness::TDHF::TDHFParameters::debug(), F, madness::WorldGopInterface::fence(), madness::TDHF::TDHFParameters::freeze(), get_calc(), get_orbital_energy(), get_reference(), get_tda_potential(), madness::World::gop, madness::CCTimer::info(), madness::inner(), madness::Function< T, NDIM >::is_initialized(), k, MADNESS_ASSERT, make_bra(), mo_ket_, msg, madness::mul(), madness::CCMessenger::output(), parameters, madness::CCTimer::print(), R, madness::CC_vecfunction::size(), madness::BaseTensor::size(), madness::World::size(), madness::CCTimer::start(), madness::CCTimer::stop(), T(), V(), and world.
Referenced by orthonormalize().
|
private |
Make the potentials to a given vector of vecfunctions (excitations)
[in] | The | vector of excitations |
[out] | The | potentials |
References madness::TDHF::TDHFParameters::debug(), get_tda_potential(), madness::CCTimer::info(), MADNESS_ASSERT, msg, parameters, V(), world, and xi.
Referenced by iterate_vectors().
|
private |
|
private |
Create a set of virtual orbitals for the initial guess.
Make the old CIS Guess the routine is now used to create virtuals
References apply_excitation_operators(), madness::TDHF::TDHFParameters::debug(), madness::WorldGopInterface::fence(), get_active_mo_ket(), get_calc(), get_orbital_energy(), madness::World::gop, madness::TDHF::TDHFParameters::guess_cm(), madness::TDHF::TDHFParameters::guess_excitation_operators(), madness::inner(), madness::load_function(), make_bra(), mo_ket_, msg, madness::detail::norm(), madness::CCMessenger::output(), parameters, plot(), madness::CCTimer::print(), Q, madness::World::rank(), madness::CC_vecfunction::size(), madness::CCMessenger::subsection(), and world.
Referenced by make_guess_from_initial_diagonalization().
|
inlinevirtual |
Implements madness::QCPropertyInterface.
Referenced by plot().
|
private |
orthonormalize a vector of excitations
[in,out] | input | the excitations, output: the orthonormalized excitations |
[in] | input | the potentials, if empty the potentials will be recalculated but NOT stored output: the transformed potentials |
References madness::TDHF::TDHFParameters::debug(), delta, get_calc(), madness::CCTimer::info(), make_overlap_matrix(), make_perturbed_fock_matrix(), msg, parameters, madness::BaseTensor::size(), madness::TDHF::TDHFParameters::thresh(), transform(), V(), and world.
Referenced by iterate_vectors().
|
private |
compute the oscillator strength in the length representation
the oscillator strength is given by
where is the excited state, and is the ground state
[in] | root | a converged root |
References a, madness::f, get_active_mo_bra(), madness::CC_vecfunction::get_vecfunction(), madness::inner(), madness::CC_vecfunction::omega, madness::Tensor< T >::sumsq(), and world.
Referenced by analyze().
|
private |
compute the oscillator strength in the velocity representation
the oscillator strength is given by
where is the excited state, and is the ground state
[in] | root | a converged root |
References a, madness::apply(), madness::f, get_active_mo_ket(), get_reference(), madness::CC_vecfunction::get_vecfunction(), madness::inner(), madness::CC_vecfunction::omega, madness::Tensor< T >::sumsq(), and world.
Referenced by analyze().
void madness::TDHF::plot | ( | const vector_real_function_3d & | vf, |
const std::string & | name | ||
) | const |
plot planes and cubes
References get_calc(), molecule, name(), parameters, madness::TDHF::TDHFParameters::plot(), madness::plot(), madness::timer::print(), timer(), and world.
Referenced by iterate_vectors(), make_virtuals(), and solve_cis().
void madness::TDHF::prepare_calculation | ( | ) |
compute non-trivial prerequisites for the calculation
References madness::Localizer::determine_frozen_orbitals(), madness::TDHF::TDHFParameters::do_oep(), enforce_core_valence_separation(), F, F_occ, madness::TDHF::TDHFParameters::freeze(), g12, get_active_mo_bra(), get_active_mo_ket(), get_calc(), get_calcparam(), get_nemo(), get_orbital_energy(), get_reference(), madness::CC_vecfunction::get_vecfunction(), make_bra(), make_mo_bra(), make_mo_ket(), mo_bra_, mo_ket_, msg, madness::TDHF::TDHFParameters::no_compute(), madness::CCMessenger::output(), parameters, print_frozen_orbitals(), Q, madness::QCCalculationParametersBase::set_derived_value(), madness::CCMessenger::subsection(), timer(), and world.
void madness::TDHF::print_frozen_orbitals | ( | ) | const |
|
inlinestatic |
References param, madness::print(), and madness::Molecule::print_parameters().
Referenced by main().
void madness::TDHF::print_xfunctions | ( | const std::vector< CC_vecfunction > & | f, |
const std::string | message | ||
) | const |
print information
References madness::f, madness::get_size(), msg, madness::CCMessenger::output_prec, madness::print(), madness::World::rank(), and world.
Referenced by iterate_vectors(), make_guess_from_initial_diagonalization(), and solve_cis().
|
inlinevirtual |
Implements madness::QCPropertyInterface.
|
inline |
std::vector< CC_vecfunction > madness::TDHF::solve_cis | ( | ) | const |
Solve the CIS equations.
[in/out] | CC_vecfunction on input the guess functions (if empty or not enough the a guess will be generated) on output the solution |
References converged_roots, madness::TDHF::TDHFParameters::dconv(), madness::TDHF::TDHFParameters::econv(), madness::TDHF::TDHFParameters::excitations(), madness::filename, filename_for_roots(), madness::CC_vecfunction::is_converged(), madness::CC_vecfunction::load_restartdata(), madness::TDHF::TDHFParameters::nexcitations(), parameters, madness::print(), madness::print_header2(), madness::TDHF::TDHFParameters::print_level(), print_xfunctions(), madness::World::rank(), madness::TDHF::TDHFParameters::restart(), sort_xfunctions(), madness::swap(), and world.
|
private |
References converged_roots, filename_for_roots(), madness::TDHF::TDHFParameters::guess_excitations(), guess_roots, madness::CCTimer::info(), initialize(), iterate_cis_final_vectors(), iterate_cis_guess_vectors(), madness::TDHF::TDHFParameters::iterating_excitations(), mo_ket_, msg, madness::TDHF::TDHFParameters::nexcitations(), madness::CCMessenger::output(), parameters, madness::CC_vecfunction::plot(), plot(), madness::CCMessenger::print_warnings(), print_xfunctions(), madness::CCMessenger::section(), sort_xfunctions(), madness::CCMessenger::subsection(), symmetrize(), and world.
|
private |
Solve TDHF equations (not ready)
References MADNESS_EXCEPTION, msg, and madness::CCMessenger::section().
std::vector< CC_vecfunction > madness::TDHF::sort_xfunctions | ( | std::vector< CC_vecfunction > | x | ) | const |
sort the xfunctions according to their excitation energy and name the excitation energies accordingly
Referenced by iterate_vectors(), and solve_cis().
void madness::TDHF::symmetrize | ( | std::vector< CC_vecfunction > & | v | ) | const |
References madness::f, madness::TDHF::TDHFParameters::freeze(), get_active_mo_ket(), get_nemo(), madness::projector_irrep::get_table(), madness::charactertable::is_abelian, MADNESS_ASSERT, parameters, madness::projector_irrep::project_on_irreps(), madness::projector_irrep::reduce(), madness::RESPONSE, symmetry_projector, and v.
Referenced by iterate_vectors(), and solve_cis().
|
static |
References std::abs(), analyze(), madness::error(), get_calcparam(), omega, parameters, prepare_calculation(), madness::QCCalculationParametersBase::print(), madness::print(), madness::World::rank(), madness::commandlineparser::set_keyval(), madness::QCCalculationParametersBase::set_user_defined_value(), solve_cis(), madness::commandlineparser::value(), madness::wall_time(), world, madness::write_test_input::write_molecule_to_test_input(), and madness::write_test_input::write_to_test_input().
Referenced by main().
|
private |
Interface to the SCF.h fock_transform function.
References madness::compress(), madness::TDHF::TDHFParameters::freeze(), madness::gaxpy(), k, MADNESS_ASSERT, parameters, madness::CC_vecfunction::set_functions(), madness::CC_vecfunction::type, and world.
|
inlineprivate |
References xi.
Referenced by orthonormalize().
|
mutableprivate |
converged roots
Referenced by get_converged_roots(), iterate_vectors(), and solve_cis().
|
private |
Fock matrix for occupied orbitals.
Referenced by get_tda_potential(), and prepare_calculation().
|
private |
Operator Structure which can handle intermediates (use for exchange with GS orbitals) Can be replaced by another potential manager
Referenced by initialize(), and prepare_calculation().
|
mutableprivate |
stored guess roots roots to feed into the cycle, sorted backwards for easier pop_back calling
Referenced by iterate_vectors(), and solve_cis().
|
private |
Referenced by get_active_mo_bra(), get_tda_potential(), make_cis_matrix(), and prepare_calculation().
|
private |
MO bra and ket.
Referenced by get_active_mo_bra(), get_active_mo_ket(), get_tda_potential(), make_cis_matrix(), make_perturbed_fock_matrix(), make_virtuals(), prepare_calculation(), and solve_cis().
|
private |
the messenger IO
Referenced by analyze(), apply_excitation_operators(), apply_G(), canonicalize(), initialize(), iterate_vectors(), make_cis_matrix(), make_guess_from_initial_diagonalization(), make_overlap_matrix(), make_perturbed_fock_matrix(), make_potentials(), make_virtuals(), orthonormalize(), prepare_calculation(), print_xfunctions(), solve_cis(), and solve_tdhf().
|
private |
The TDHFParameters for the Calculations.
Referenced by TDHF(), analyze(), apply_excitation_operators(), apply_G(), canonicalize(), check_consistency(), get_active_mo_bra(), get_active_mo_ket(), get_parameters(), get_tda_potential(), initialize(), iterate_cis_final_vectors(), iterate_cis_guess_vectors(), iterate_vectors(), make_bra(), make_cis_matrix(), make_guess_from_initial_diagonalization(), make_mo_bra(), make_mo_ket(), make_overlap_matrix(), make_perturbed_fock_matrix(), make_potentials(), make_virtuals(), orthonormalize(), plot(), prepare_calculation(), print_frozen_orbitals(), solve_cis(), symmetrize(), test(), and transform().
|
private |
the Projector to the virtual space
Referenced by apply_G(), get_tda_potential(), iterate_vectors(), make_virtuals(), and prepare_calculation().
|
private |
The Nemo structure (convenience)
Referenced by get_calc(), get_calcparam(), get_nemo(), get_orbital_energy(), get_reference(), make_bra(), and set_reference().
|
private |
the symmetry projector
Referenced by get_symmetry_projector(), initialize(), make_guess_from_initial_diagonalization(), and symmetrize().
|
private |
The MPI Communicator.
Referenced by TDHF(), madness::TDHF::TDHFParameters::TDHFParameters(), analyze(), apply_excitation_operators(), apply_G(), canonicalize(), enforce_core_valence_separation(), get_tda_potential(), initialize(), iterate_vectors(), make_bra(), make_cis_matrix(), make_guess_from_initial_diagonalization(), make_mo_bra(), make_mo_ket(), make_overlap_matrix(), make_perturbed_fock_matrix(), make_potentials(), make_virtuals(), orthonormalize(), oscillator_strength_length(), oscillator_strength_velocity(), plot(), prepare_calculation(), print_xfunctions(), solve_cis(), test(), and transform().