1#ifndef EXX_LRI_INTERFACE_HPP
2#define EXX_LRI_INTERFACE_HPP
19template<
typename T,
typename Tdata>
26 this->exx_ptr->init(mpi_comm, ucell, kv, orb);
27 this->flag_finish.init =
true;
30template<
typename T,
typename Tdata>
34 if(!this->flag_finish.init)
35 {
throw std::runtime_error(
"Exx init unfinished when "+std::string(__FILE__)+
" line "+std::to_string(__LINE__)); }
37 this->exx_ptr->cal_exx_ions(ucell, write_cv);
39 this->flag_finish.ions =
true;
42template<
typename T,
typename Tdata>
49 if(!this->flag_finish.init || !this->flag_finish.ions)
51 throw std::runtime_error(
"Exx init unfinished when "
52 +std::string(__FILE__)+
" line "+std::to_string(__LINE__));
55 this->exx_ptr->cal_exx_elec(Ds, ucell, pv, p_symrot);
57 this->flag_finish.elec =
true;
60template<
typename T,
typename Tdata>
64 if(!this->flag_finish.init || !this->flag_finish.ions)
66 throw std::runtime_error(
"Exx init unfinished when "+std::string(__FILE__)+
" line "+std::to_string(__LINE__));
68 if(!this->flag_finish.elec)
70 throw std::runtime_error(
"Exx Hamiltonian unfinished when "+std::string(__FILE__)
71 +
" line "+std::to_string(__LINE__));
74 this->exx_ptr->cal_exx_force(nat);
76 this->flag_finish.force =
true;
79template<
typename T,
typename Tdata>
83 if(!this->flag_finish.init || !this->flag_finish.ions)
85 throw std::runtime_error(
"Exx init unfinished when "
86 +std::string(__FILE__)+
" line "+std::to_string(__LINE__));
88 if(!this->flag_finish.elec)
90 throw std::runtime_error(
"Exx Hamiltonian unfinished when "
91 +std::string(__FILE__)+
" line "+std::to_string(__LINE__));
94 this->exx_ptr->cal_exx_stress(omega, lat0);
96 this->flag_finish.stress =
true;
99template<
typename T,
typename Tdata>
108 if (this->exx_spacegroup_symmetry)
111 this->symrot_.find_irreducible_sector(
115 this->symrot_.cal_Ms(kv, ucell, pv);
119template<
typename T,
typename Tdata>
160 if (this->exx_spacegroup_symmetry)
166 { this->mix_DMk_2D.set_mixing(
nullptr); }
168 { this->mix_DMk_2D.set_mixing(chgmix.
get_mixing()); }
170 this->two_level_step = 0;
175template<
typename T,
typename Tdata>
186 && (this->two_level_step
191 && this->two_level_step == 0
195 const bool flag_restart = (iter == 1) ?
true :
false;
199 if (this->exx_spacegroup_symmetry)
200 { this->mix_DMk_2D.mix(symrot_.restore_dm(kv,dm_in.get_DMK_vector(), *dm_in.get_paraV_pointer()), flag_restart); }
202 { this->mix_DMk_2D.mix(dm_in.get_DMK_vector(), flag_restart); }
203 const std::vector<std::map<TA, std::map<TAC, RI::Tensor<Tdata>>>>
205 ? RI_2D_Comm::split_m2D_ktoR<Tdata>(
207 *this->exx_ptr->p_kv,
208 this->mix_DMk_2D.get_DMk_gamma_out(),
209 *dm_in.get_paraV_pointer(),
211 : RI_2D_Comm::split_m2D_ktoR<Tdata>(
213 *this->exx_ptr->p_kv,
214 this->mix_DMk_2D.get_DMk_k_out(),
215 *dm_in.get_paraV_pointer(),
217 this->exx_spacegroup_symmetry);
219 if (this->exx_spacegroup_symmetry &&
GlobalC::exx_info.info_ri.exx_symmetry_realspace)
220 { this->cal_exx_elec(Ds, ucell,*dm_in.get_paraV_pointer(), &this->symrot_); }
222 { this->cal_exx_elec(Ds, ucell,*dm_in.get_paraV_pointer()); }
225 if(istep > 0 && flag_restart)
226 { cal(*dm_last_step); }
233template<
typename T,
typename Tdata>
243 && this->two_level_step == 0 && iter == 1)
249 catch (
const std::exception& e)
250 { std::cout <<
"WARNING: Cannot read Eexx from disk, the energy of the 1st loop will be wrong, sbut it does not influence the subsequent loops." << std::endl; }
255 elec.
set_exx(this->get_Eexx());
263template<
typename T,
typename Tdata>
270 const double& scf_ene_thr,
276 if (
GlobalC::restart.info_save.save_H && (this->two_level_step > 0 || istep > 0)
317 this->dm_last_step = dm;
318 conv_esolver = this->exx_after_converge(
332template<
typename T,
typename Tdata>
342 const double& scf_ene_thr)
345 auto restart_reset = [
this]()
348 this->exx_ptr->Eexx = 0;
360 if (this->two_level_step || istep > 0)
370 std::cout <<
" Entering 2nd SCF, where EXX is updated" << std::endl;
371 this->two_level_step++;
379 { std::cout <<
FmtCore::format(
" deltaE (eV) from outer loop: %.8e \n", ediff); }
382 || (iter == 1 && this->two_level_step != 0)
383 || (ediff < scf_ene_thr && this->two_level_step != 0))
390 this->etot_last_outer_loop = etot;
392 if (this->two_level_step == 0)
395 std::cout <<
" Updating EXX " << std::flush;
396 timeval t_start; gettimeofday(&t_start,
nullptr);
399 const bool flag_restart = (this->two_level_step == 0 &&
PARAM.
inp.
init_wfc !=
"file") ?
true :
false;
401 if (this->exx_spacegroup_symmetry)
407 const std::vector<std::map<int, std::map<std::pair<int, std::array<int, 3>>, RI::Tensor<Tdata>>>>
408 Ds = std::is_same<T, double>::value
409 ? RI_2D_Comm::split_m2D_ktoR<Tdata>(ucell,*this->exx_ptr->p_kv, this->mix_DMk_2D.get_DMk_gamma_out(), *dm.
get_paraV_pointer(), nspin)
410 : RI_2D_Comm::split_m2D_ktoR<Tdata>(ucell,*this->exx_ptr->p_kv, this->mix_DMk_2D.get_DMk_k_out(), *dm.
get_paraV_pointer(), nspin, this->exx_spacegroup_symmetry);
412 if (this->exx_spacegroup_symmetry &&
GlobalC::exx_info.info_ri.exx_symmetry_realspace)
417 this->two_level_step++;
419 timeval t_end; gettimeofday(&t_end,
nullptr);
420 std::cout <<
"and rerun SCF\t"
421 << std::setprecision(3) << std::setiosflags(std::ios::scientific)
422 << (double)(t_end.tv_sec-t_start.tv_sec) + (double)(t_end.tv_usec-t_start.tv_usec)/1000000.0
423 << std::defaultfloat <<
" (s)" << std::endl;
Atom_pseudo ncpp
Definition atom_spec.h:13
Definition charge_mixing.h:9
Base_Mixing::Mixing * get_mixing() const
Definition charge_mixing.h:103
void close_kerker_gg0()
Definition charge_mixing.h:52
void cal_exx_force(const int &nat)
: in cal_exx_force: Exx_LRI::cal_exx_force()
Definition Exx_LRI_interface.hpp:61
void cal_exx_stress(const double &omega, const double &lat0)
: in cal_exx_stress: Exx_LRI::cal_exx_stress()
Definition Exx_LRI_interface.hpp:80
void exx_beforescf(const int istep, const K_Vectors &kv, const Charge_Mixing &chgmix, const UnitCell &ucell, const LCAO_Orbitals &orb)
in beforescf: set xc type, opt_orb, do DM mixing
Definition Exx_LRI_interface.hpp:120
std::pair< TA, TC > TAC
Definition Exx_LRI_interface.h:37
void cal_exx_ions(const UnitCell &ucell, const bool write_cv=false)
: in cal_exx_ions: Exx_LRI::cal_exx_ions()
Definition Exx_LRI_interface.hpp:31
void init(const MPI_Comm &mpi_comm, const UnitCell &ucell, const K_Vectors &kv, const LCAO_Orbitals &orb)
in init: Exx_LRI::init()
Definition Exx_LRI_interface.hpp:20
void exx_hamilt2rho(elecstate::ElecState &elec, const Parallel_Orbitals &pv, const int iter)
in hamilt2rho: calculate Hexx and Eexx
Definition Exx_LRI_interface.hpp:234
bool exx_after_converge(const UnitCell &ucell, hamilt::Hamilt< T > &hamilt, const elecstate::DensityMatrix< T, double > &dm, const K_Vectors &kv, const int &nspin, int &iter, const int &istep, const double &etot, const double &scf_ene_thr)
: in do_after_converge: add exx operators; do DM mixing if seperate loop
Definition Exx_LRI_interface.hpp:333
void exx_before_all_runners(const K_Vectors &kv, const UnitCell &ucell, const Parallel_2D &pv)
in before_all_runners: set symmetry according to irreducible k-points since k-points are not reduced ...
Definition Exx_LRI_interface.hpp:100
void exx_eachiterinit(const int istep, const UnitCell &ucell, const elecstate::DensityMatrix< T, double > &dm, const K_Vectors &kv, const int &iter)
in eachiterinit: do DM mixing and calculate Hexx when entering 2nd SCF
Definition Exx_LRI_interface.hpp:176
int TA
Definition Exx_LRI_interface.h:35
void cal_exx_elec(const std::vector< std::map< TA, std::map< TAC, RI::Tensor< Tdata > > > > &Ds, const UnitCell &ucell, const Parallel_Orbitals &pv, const ModuleSymmetry::Symmetry_rotation *p_symrot=nullptr)
: in cal_exx_elec: Exx_LRI::cal_exx_elec()
Definition Exx_LRI_interface.hpp:43
void exx_iter_finish(const K_Vectors &kv, const UnitCell &ucell, hamilt::Hamilt< T > &hamilt, elecstate::ElecState &elec, elecstate::DensityMatrix< T, double > *dm, Charge_Mixing &chgmix, const double &scf_ene_thr, int &iter, const int istep, bool &conv_esolver)
in iter_finish: write Hexx, do something according to whether SCF is converged
Definition Exx_LRI_interface.hpp:264
static std::string format(const char *fmt, const Ts &... args)
static function to format data
Definition formatter.h:41
int get_nkstot_full() const
Definition klist.h:78
int get_nks() const
Definition klist.h:68
Definition symmetry_rotation.h:16
static int symm_flag
Definition symmetry.h:30
This class packs the basic information of 2D-block-cyclic parallel distribution of an arbitrary matri...
Definition parallel_2d.h:12
Definition parallel_orbitals.h:9
const Input_para & inp
Definition parameter.h:26
const System_para & globalv
Definition parameter.h:30
std::string folder
Definition restart.h:31
Info_Load info_load
Definition restart.h:29
bool load_disk(const std::string label, const int index, const int size, T *data, const bool error_quit=true) const
Definition restart.h:43
bool save_disk(const std::string label, const int index, const int size, T *data, const bool error_quit=true) const
Definition restart.h:34
Atom * atoms
Definition unitcell.h:19
Lattice lat
Definition unitcell.h:27
ModuleSymmetry::Symmetry symm
Definition unitcell.h:57
Statistics st
Definition unitcell.h:46
static int get_func_type()
Definition xc_functional.h:67
static void set_xc_type(const std::string xc_func_in)
Definition xc_functional.cpp:48
Definition density_matrix.h:36
const std::vector< std::vector< TK > > & get_DMK_vector() const
get pointer vector of DMK
Definition density_matrix.h:164
const Parallel_Orbitals * get_paraV_pointer() const
get pointer of paraV
Definition density_matrix.h:176
Definition elecstate.h:15
fenergy f_en
energies contribute to the total free energy
Definition elecstate.h:151
void set_exx(const double &Eexx)
calculation if converged
Definition elecstate_exx.cpp:8
std::string xc_func
Definition pseudo.h:25
Exx_Info exx_info
Definition test_xc.cpp:29
Restart restart
Definition for_testing_input_conv.h:255
int MY_RANK
global index of process
Definition global_variable.cpp:21
const double Ry_to_eV
Definition constants.h:81
void TITLE(const std::string &class_name, const std::string &function_name, const bool disable)
Definition tool_title.cpp:18
void write_Hexxs_csr(const std::string &file_name, const UnitCell &ucell, const std::map< int, std::map< TAC, RI::Tensor< Tdata > > > &Hexxs)
write Hexxs in CSR format
void bcast_double(double *object, const int n)
Definition parallel_common.cpp:49
std::array< int, 3 > get_Born_vonKarmen_period(const K_Vectors &kv)
Definition RI_Util.hpp:16
std::vector< std::array< Tcell, Ndim > > get_Born_von_Karmen_cells(const std::array< Tcell, Ndim > &Born_von_Karman_period)
Definition RI_Util.hpp:34
Parameter PARAM
Definition parameter.cpp:3
bool separate_loop
Definition exx_info.h:35
double hybrid_alpha
Definition exx_info.h:31
size_t hybrid_step
Definition exx_info.h:36
Exx_Info_Global info_global
Definition exx_info.h:38
bool restart_exx
Definition restart.h:27
bool gamma_only_local
Definition system_parameter.h:38
double etot
the total free energy
Definition fp_energy.h:18
double exx
the exact exchange energy.
Definition fp_energy.h:31