Skip to content

Commit 368495d

Browse files
maki49pre-commit-ci-lite[bot]kirk0830
authored
Feature: LR-TDDFT support reading fxc from file or calculating fxc by a specified charge file (deepmodeling#5393)
* read fxc or charge for fxc from file * move xc-dependent functions to a new file * minor fix * rename files * rename init_fxc as init_xc_kernel * update grad and lapl * delete useless matrix transformer * update comments * rename: lr_init_xc_kernel * add const before std::set * rename variables in PotHxcLR * rename gdr as gradrho * rename spinsize as n_component * use something else to replace the for-loop * [pre-commit.ci lite] apply automatic fixes * flatten the map * use std::any_of * rename new/delete_p2 as new/delete_pointer_dim2 * a usage of std::inner_product * rename 2order_nested_ptr * add annotation and minor changes Co-authored-by: kirk0830 <[email protected]> * redesign KernelXC: constructor sets all the members fix compile fix a initialize bug * rename and update doc --------- Co-authored-by: pre-commit-ci-lite[bot] <117423508+pre-commit-ci-lite[bot]@users.noreply.github.com> Co-authored-by: kirk0830 <[email protected]>
1 parent 7dcc282 commit 368495d

21 files changed

+484
-497
lines changed

docs/advanced/input_files/input-main.md

+10
Original file line numberDiff line numberDiff line change
@@ -423,6 +423,7 @@
423423
- [pexsi\_zero\_thr](#pexsi_zero_thr)
424424
- [Linear Response TDDFT](#linear-response-tddft)
425425
- [xc\_kernel](#xc_kernel)
426+
- [lr\_init\_xc\_kernel](#lr_init_xc_kernel)
426427
- [lr\_solver](#lr_solver)
427428
- [lr\_thr](#lr_thr)
428429
- [nocc](#nocc)
@@ -3943,6 +3944,15 @@ These parameters are used to solve the excited states using. e.g. LR-TDDFT.
39433944
Currently supported: `RPA`, `LDA`, `PBE`, `HSE`, `HF`.
39443945
- **Default**: LDA
39453946

3947+
### lr_init_xc_kernel
3948+
3949+
- **Type**: String
3950+
- **Description**: The method to initalize the xc kernel.
3951+
- "default": Calculate xc kerenel ($f_\text{xc}$) from the ground-state charge density.
3952+
- "file": Read the xc kernel $f_\text{xc}$ on grid from the provided files. The following words should be the paths of ".cube" files, where the first 1 (*[nspin](#nspin)==1*) or 3 (*[nspin](#nspin)==2*, namely spin-aa, spin-ab and spin-bb) will be read in. The parameter [xc_kernel](#xc_kernel) will be invalid. Now only LDA-type kernel is supproted as the potential will be calculated by directly multiplying the transition density.
3953+
- "from_charge_file": Calculate fxc from the charge density read from the provided files. The following words should be the paths of ".cube" files, where the first [nspin]($nspin) files will be read in.
3954+
- **Default**: "default"
3955+
39463956
### lr_solver
39473957

39483958
- **Type**: String

source/Makefile.Objects

+1-1
Original file line numberDiff line numberDiff line change
@@ -727,7 +727,7 @@ OBJS_TENSOR=tensor.o\
727727
dmr_complex.o\
728728
operator_lr_hxc.o\
729729
operator_lr_exx.o\
730-
kernel_xc.o\
730+
xc_kernel.o\
731731
pot_hxc_lrtd.o\
732732
lr_spectrum.o\
733733
hamilt_casida.o\

source/module_io/read_input_item_tddft.cpp

+14
Original file line numberDiff line numberDiff line change
@@ -309,6 +309,20 @@ void ReadInput::item_lr_tddft()
309309
read_sync_string(input.xc_kernel);
310310
this->add_item(item);
311311
}
312+
{
313+
Input_Item item("lr_init_xc_kernel");
314+
item.annotation = "The method to initalize the xc kernel";
315+
item.read_value = [](const Input_Item& item, Parameter& para) {
316+
size_t count = item.get_size();
317+
auto& ifxc = para.input.lr_init_xc_kernel;
318+
for (int i = 0; i < count; i++) { ifxc.push_back(item.str_values[i]); }
319+
};
320+
item.reset_value = [](const Input_Item& item, Parameter& para) {
321+
if (para.input.lr_init_xc_kernel.empty()) { para.input.lr_init_xc_kernel.push_back("default"); }
322+
};
323+
sync_stringvec(input.lr_init_xc_kernel, para.input.lr_init_xc_kernel.size(), "default");
324+
this->add_item(item);
325+
}
312326
{
313327
Input_Item item("lr_solver");
314328
item.annotation = "the eigensolver for LR-TDDFT";

source/module_io/test/read_input_ptest.cpp

+1
Original file line numberDiff line numberDiff line change
@@ -421,6 +421,7 @@ TEST_F(InputParaTest, ParaRead)
421421
EXPECT_EQ(param.inp.nocc, param.inp.nbands);
422422
EXPECT_EQ(param.inp.nvirt, 1);
423423
EXPECT_EQ(param.inp.xc_kernel, "LDA");
424+
EXPECT_EQ(param.inp.lr_init_xc_kernel[0], "default");
424425
EXPECT_EQ(param.inp.lr_solver, "dav");
425426
EXPECT_DOUBLE_EQ(param.inp.lr_thr, 1e-2);
426427
EXPECT_FALSE(param.inp.lr_unrestricted);

source/module_lr/CMakeLists.txt

+2-7
Original file line numberDiff line numberDiff line change
@@ -17,13 +17,8 @@ if(ENABLE_LCAO)
1717
potentials/pot_hxc_lrtd.cpp
1818
lr_spectrum.cpp
1919
hamilt_casida.cpp
20-
esolver_lrtd_lcao.cpp)
21-
22-
if(ENABLE_LIBXC)
23-
list(APPEND objects
24-
potentials/kernel_xc.cpp
25-
)
26-
endif()
20+
esolver_lrtd_lcao.cpp
21+
potentials/xc_kernel.cpp)
2722

2823
add_library(
2924
lr

source/module_lr/esolver_lrtd_lcao.cpp

+12-6
Original file line numberDiff line numberDiff line change
@@ -65,8 +65,8 @@ inline int cal_nupdown_form_occ(const ModuleBase::matrix& wg)
6565
template<typename T, typename TR>
6666
void LR::ESolver_LR<T, TR>::parameter_check()const
6767
{
68-
std::set<std::string> lr_solvers = { "dav", "lapack" , "spectrum", "dav_subspace", "cg" };
69-
std::set<std::string> xc_kernels = { "rpa", "lda", "pbe", "hf" , "hse" };
68+
const std::set<std::string> lr_solvers = { "dav", "lapack" , "spectrum", "dav_subspace", "cg" };
69+
const std::set<std::string> xc_kernels = { "rpa", "lda", "pwlda", "pbe", "hf" , "hse" };
7070
if (lr_solvers.find(this->input.lr_solver) == lr_solvers.end()) {
7171
throw std::invalid_argument("ESolver_LR: unknown type of lr_solver");
7272
}
@@ -104,7 +104,13 @@ void LR::ESolver_LR<T, TR>::set_dimension()
104104
GlobalV::ofs_running << "number of excited states to be solved: " << this->nstates << std::endl;
105105
if (input.ri_hartree_benchmark == "aims" && !input.aims_nbasis.empty())
106106
{
107-
this->nbasis = [&]() -> int { int nbas = 0; for (int it = 0;it < ucell.ntype;++it) { nbas += ucell.atoms[it].na * input.aims_nbasis[it]; };return nbas;}();
107+
// calculate total number of basis funcs, see https://en.cppreference.com/w/cpp/algorithm/inner_product
108+
this->nbasis = std::inner_product(input.aims_nbasis.begin(), /* iterator1.begin */
109+
input.aims_nbasis.end(), /* iterator1.end */
110+
ucell.atoms, /* iterator2.begin */
111+
0, /* init value */
112+
std::plus<int>(), /* iter op1 */
113+
[](const int& a, const Atom& b) { return a * b.na; }); /* iter op2 */
108114
std::cout << "nbasis from aims: " << this->nbasis << std::endl;
109115
}
110116
}
@@ -588,11 +594,11 @@ void LR::ESolver_LR<T, TR>::init_pot(const Charge& chg_gs)
588594
{
589595
using ST = PotHxcLR::SpinType;
590596
case 1:
591-
this->pot[0] = std::make_shared<PotHxcLR>(xc_kernel, this->pw_rho, &ucell, &chg_gs, ST::S1);
597+
this->pot[0] = std::make_shared<PotHxcLR>(xc_kernel, *this->pw_rho, ucell, chg_gs, GlobalC::Pgrid, ST::S1, input.lr_init_xc_kernel);
592598
break;
593599
case 2:
594-
this->pot[0] = std::make_shared<PotHxcLR>(xc_kernel, this->pw_rho, &ucell, &chg_gs, openshell ? ST::S2_updown : ST::S2_singlet);
595-
this->pot[1] = std::make_shared<PotHxcLR>(xc_kernel, this->pw_rho, &ucell, &chg_gs, openshell ? ST::S2_updown : ST::S2_triplet);
600+
this->pot[0] = std::make_shared<PotHxcLR>(xc_kernel, *this->pw_rho, ucell, chg_gs, GlobalC::Pgrid, openshell ? ST::S2_updown : ST::S2_singlet, input.lr_init_xc_kernel);
601+
this->pot[1] = std::make_shared<PotHxcLR>(xc_kernel, *this->pw_rho, ucell, chg_gs, GlobalC::Pgrid, openshell ? ST::S2_updown : ST::S2_triplet, input.lr_init_xc_kernel);
596602
break;
597603
default:
598604
throw std::invalid_argument("ESolver_LR: nspin must be 1 or 2");

source/module_lr/lr_spectrum.cpp

+6-6
Original file line numberDiff line numberDiff line change
@@ -53,7 +53,7 @@ void LR::LR_Spectrum<double>::oscillator_strength(Grid_Driver& gd, const std::ve
5353

5454
// 2. transition density
5555
double** rho_trans;
56-
LR_Util::new_p2(rho_trans, 1, this->rho_basis.nrxx);
56+
LR_Util::_allocate_2order_nested_ptr(rho_trans, 1, this->rho_basis.nrxx);
5757
this->cal_gint_rho(rho_trans, this->rho_basis.nrxx);
5858

5959
// 3. transition dipole moment
@@ -67,7 +67,7 @@ void LR::LR_Spectrum<double>::oscillator_strength(Grid_Driver& gd, const std::ve
6767
ModuleBase::Vector3<double> rc = rd * ucell.latvec * ucell.lat0; // real coordinate
6868
transition_dipole_[istate] += rc * rho_trans[0][ir];
6969
}
70-
LR_Util::delete_p2(rho_trans, 1);
70+
LR_Util::_deallocate_2order_nested_ptr(rho_trans, 1);
7171
}
7272
transition_dipole_[istate] *= (ucell.omega / static_cast<double>(gint->get_ncxyz())); // dv
7373
Parallel_Reduce::reduce_all(transition_dipole_[istate].x);
@@ -114,8 +114,8 @@ void LR::LR_Spectrum<std::complex<double>>::oscillator_strength(Grid_Driver& gd,
114114
// 2. transition density
115115
double** rho_trans_real;
116116
double** rho_trans_imag;
117-
LR_Util::new_p2(rho_trans_real, 1, this->rho_basis.nrxx);
118-
LR_Util::new_p2(rho_trans_imag, 1, this->rho_basis.nrxx);
117+
LR_Util::_allocate_2order_nested_ptr(rho_trans_real, 1, this->rho_basis.nrxx);
118+
LR_Util::_allocate_2order_nested_ptr(rho_trans_imag, 1, this->rho_basis.nrxx);
119119
// real part
120120
LR_Util::get_DMR_real_imag_part(DM_trans, DM_trans_real_imag, ucell.nat, 'R');
121121
this->gint->transfer_DM2DtoGrid(DM_trans_real_imag.get_DMR_vector());
@@ -140,8 +140,8 @@ void LR::LR_Spectrum<std::complex<double>>::oscillator_strength(Grid_Driver& gd,
140140
ModuleBase::Vector3<std::complex<double>> rc_complex(rc.x, rc.y, rc.z);
141141
transition_dipole_[istate] += rc_complex * std::complex<double>(rho_trans_real[0][ir], rho_trans_imag[0][ir]);
142142
}
143-
LR_Util::delete_p2(rho_trans_real, 1);
144-
LR_Util::delete_p2(rho_trans_imag, 1);
143+
LR_Util::_deallocate_2order_nested_ptr(rho_trans_real, 1);
144+
LR_Util::_deallocate_2order_nested_ptr(rho_trans_imag, 1);
145145
}
146146
transition_dipole_[istate] *= (ucell.omega / static_cast<double>(gint->get_ncxyz())); // dv
147147
Parallel_Reduce::reduce_all(transition_dipole_[istate].x);

source/module_lr/operator_casida/operator_lr_hxc.cpp

+6-6
Original file line numberDiff line numberDiff line change
@@ -61,15 +61,15 @@ namespace LR
6161
// \f[ \tilde{\rho}(r)=\sum_{\mu_j, \mu_b}\tilde{\rho}_{\mu_j,\mu_b}\phi_{\mu_b}(r)\phi_{\mu_j}(r) \f]
6262
double** rho_trans;
6363
const int& nrxx = this->pot.lock()->nrxx;
64-
LR_Util::new_p2(rho_trans, 1, nrxx); // currently gint_kernel_rho uses PARAM.inp.nspin, it needs refactor
64+
LR_Util::_allocate_2order_nested_ptr(rho_trans, 1, nrxx); // currently gint_kernel_rho uses PARAM.inp.nspin, it needs refactor
6565
ModuleBase::GlobalFunc::ZEROS(rho_trans[0], nrxx);
6666
Gint_inout inout_rho(rho_trans, Gint_Tools::job_type::rho, 1, false);
6767
this->gint->cal_gint(&inout_rho);
6868

6969
// 3. v_hxc = f_hxc * rho_trans
7070
ModuleBase::matrix vr_hxc(1, nrxx); //grid
71-
this->pot.lock()->cal_v_eff(rho_trans, &GlobalC::ucell, vr_hxc, ispin_ks);
72-
LR_Util::delete_p2(rho_trans, 1);
71+
this->pot.lock()->cal_v_eff(rho_trans, GlobalC::ucell, vr_hxc, ispin_ks);
72+
LR_Util::_deallocate_2order_nested_ptr(rho_trans, 1);
7373

7474
// 4. V^{Hxc}_{\mu,\nu}=\int{dr} \phi_\mu(r) v_{Hxc}(r) \phi_\mu(r)
7575
Gint_inout inout_vlocal(vr_hxc.c, 0, Gint_Tools::job_type::vlocal);
@@ -103,18 +103,18 @@ namespace LR
103103
double** rho_trans;
104104
const int& nrxx = this->pot.lock()->nrxx;
105105

106-
LR_Util::new_p2(rho_trans, 1, nrxx); // nspin=1 for transition density
106+
LR_Util::_allocate_2order_nested_ptr(rho_trans, 1, nrxx); // nspin=1 for transition density
107107
ModuleBase::GlobalFunc::ZEROS(rho_trans[0], nrxx);
108108
Gint_inout inout_rho(rho_trans, Gint_Tools::job_type::rho, 1, false);
109109
this->gint->cal_gint(&inout_rho);
110110
// print_grid_nonzero(rho_trans[0], nrxx, 10, "rho_trans");
111111

112112
// 3. v_hxc = f_hxc * rho_trans
113113
ModuleBase::matrix vr_hxc(1, nrxx); //grid
114-
this->pot.lock()->cal_v_eff(rho_trans, &GlobalC::ucell, vr_hxc, ispin_ks);
114+
this->pot.lock()->cal_v_eff(rho_trans, GlobalC::ucell, vr_hxc, ispin_ks);
115115
// print_grid_nonzero(vr_hxc.c, this->poticab->nrxx, 10, "vr_hxc");
116116

117-
LR_Util::delete_p2(rho_trans, 1);
117+
LR_Util::_deallocate_2order_nested_ptr(rho_trans, 1);
118118

119119
// 4. V^{Hxc}_{\mu,\nu}=\int{dr} \phi_\mu(r) v_{Hxc}(r) \phi_\mu(r)
120120
Gint_inout inout_vlocal(vr_hxc.c, 0, Gint_Tools::job_type::vlocal);

source/module_lr/potentials/kernel.h

-30
This file was deleted.

0 commit comments

Comments
 (0)