ABACUS develop
Atomic-orbital Based Ab-initio Computation at UStc
Loading...
Searching...
No Matches
input_parameter.h
Go to the documentation of this file.
1#ifndef INPUT_PARAMETER_H
2#define INPUT_PARAMETER_H
3#include "md_parameter.h"
5
6#include <string>
7#include <vector>
8
9// It stores all input parameters both defined in INPUT file and not defined in
10// INPUT file
12{
13 // ---------------------------------------------------------------
14 // -------------- INPUT Parameters ----------------
15 // ---------------------------------------------------------------
16 // ============== #Parameters (1.System) =====================
17 std::string suffix = "ABACUS";
18 int ntype = 0;
19 std::string calculation = "scf";
22 std::string esolver_type = "ksdft";
23 /* symmetry level:
24 -1, no symmetry at all;
25 0, only basic time reversal would be considered;
26 1, point group symmetry would be considered*/
27 std::string symmetry = "default";
28 double symmetry_prec = 1.0e-6;
29 bool symmetry_autoclose = true;
31 bool cal_force = false;
32 bool cal_stress = false;
33 int kpar = 1;
34 int bndpar = 1;
35 std::string latname = "none";
36 double ecutwfc = 0;
37 double ecutrho = 0;
38
39 int nx = 0, ny = 0, nz = 0;
40 int ndx = 0, ndy = 0, ndz = 0;
41
42 double cell_factor = 1.2;
43 double erf_ecut = 0;
44 double erf_height = 0;
45 double erf_sigma = 0.1;
46 int fft_mode = 0;
47 std::string init_wfc = "atomic";
48 int pw_seed = 0;
49 std::string init_chg = "atomic";
50 bool dm_to_rho = false;
51 std::string chg_extrap = "default";
52 bool init_vel = false;
53
54 std::string input_file = "INPUT";
55 std::string stru_file = "STRU";
57 std::string kpoint_file = "KPT";
58 std::string pseudo_dir = "";
59 std::string orbital_dir = "";
60 std::string read_file_dir = "auto";
61 bool restart_load = false;
62 std::string wannier_card = "none";
63 int mem_saver = 0;
64 int diago_proc = 0;
65 int nbspline = -1;
66 std::vector<double> kspacing = {0.0, 0.0, 0.0};
67 double min_dist_coef = 0.2;
68
69 std::string device = "auto";
70 std::string precision = "double";
71
72 // ============== #Parameters (2.Electronic structure) ===========================
73 std::string ks_solver = "default";
74 std::string basis_type = "pw";
75 int nbands = 0;
76 double nelec = 0.0;
77 double nelec_delta = 0.0;
78 double nupdown = 0.0;
79 std::string dft_functional = "default";
80 double xc_temperature = 0.0;
81 double pseudo_rcut = 15.0;
82 bool pseudo_mesh = false;
84 int nspin = 1;
85 int pw_diag_nmax = 50;
86 double pw_diag_thr = 0.01;
87 bool diago_smooth_ethr = false;
88 int pw_diag_ndim = 4;
89 int diago_cg_prec = 1;
90 int diag_subspace = 0; // 0: Lapack, 1: elpa, 2: scalapack
91 bool use_k_continuity = false;
92
93 std::string smearing_method = "gauss";
97 double smearing_sigma = 0.015;
98
99 std::string mixing_mode = "broyden";
100 double mixing_beta = -1.0;
101 int mixing_ndim = 8;
102 double mixing_restart = 0.0;
104 double mixing_gg0 = 1.0;
105 double mixing_beta_mag = -10.0;
106 double mixing_gg0_mag = 0.0;
107 double mixing_gg0_min = 0.1;
108 double mixing_angle = -10.0;
109 bool mixing_tau = false;
110 bool mixing_dftu = false;
111 bool mixing_dmr = false;
112
113 bool gamma_only = false;
114 int scf_nmax = 100;
115 double scf_thr = -1.0;
116 double scf_ene_thr = -1.0;
117 int scf_thr_type = -1;
118// bool final_scf = false; ///< whether to do final scf
119 bool scf_os_stop = false;
120 double scf_os_thr = -0.01;
121 int scf_os_ndim = 0;
122 int sc_os_ndim = 5;
123
124 bool lspinorb = false;
125 bool noncolin = false;
126 double soc_lambda = 1.0;
127
128 // ============== #Parameters (3.LCAO) ===========================
129 int nb2d = 0;
130 int lmaxmax = 2;
131 double lcao_ecut = 0.0;
132 double lcao_dk = 0.01;
133 double lcao_dr = 0.01;
134 double lcao_rmax = 30.0;
135 double search_radius = -1.0;
136 int bx = 0, by = 0, bz = 0;
138 int nstream = 4;
139 std::string bessel_nao_ecut = "default";
140 double bessel_nao_tolerence = 1e-12;
141 std::vector<double> bessel_nao_rcuts = {};
142 bool bessel_nao_smooth = true;
143 double bessel_nao_sigma = 0.1;
144 // ==========================================================
145 // spherical bessel Peize Lin added on 2022-12-15
146 // ==========================================================
147 // the following are used when generating orb_matrix.dat
148 // int bessel_nao_lmax; ///< lmax used in descriptor
149
150 // ============== #Parameters (4.Relaxation) ===========================
151 std::string relax_method = "cg";
152 bool relax_new = true;
153 bool relax = false;
154 double relax_scale_force = 0.5;
155 int relax_nmax = -1;
156 double relax_cg_thr = 0.5;
157 double force_thr = -1;
158 double force_thr_ev = -1;
159 double force_zero_out = 0;
160 double stress_thr = 0.5;
161 double press1 = 0;
162 double press2 = 0;
163 double press3 = 0;
164 double relax_bfgs_w1 = 0.01;
165 double relax_bfgs_w2 = 0.5;
166 double relax_bfgs_rmax = 0.2;
167 double relax_bfgs_rmin = 1e-05;
168 double relax_bfgs_init = 0.5;
169 std::string fixed_axes = "None";
170 bool fixed_ibrav = false;
172 bool fixed_atoms = false;
173
174 // ============== #Parameters (5.Molecular dynamics) ===========================
176 double ref_cell_factor = 1;
178 bool cal_syns = false;
179 double dmax = 0.01;
180
181 // ============== #Parameters (6.OFDFT) ===========================
182 // OFDFT sunliang added on 2022-05-05
183 std::string of_kinetic = "wt";
184 std::string of_method = "tn";
185 std::string of_conv = "energy";
187 double of_tole = 1e-06;
189 double of_tolp = 1e-05;
191 double of_tf_weight = 1.0;
192 double of_vw_weight = 1.0;
193 double of_wt_alpha = 5. / 6.;
194 double of_wt_beta = 5. / 6.;
195 double of_wt_rho0 = 0.0;
196 bool of_hold_rho0 = false;
199 double of_lkt_a = 1.3;
200 bool of_full_pw = true;
204 bool of_read_kernel = false;
207 std::string of_kernel_file = "WTkernel.txt";
208 double of_xwm_kappa = 0.0;
209 double of_xwm_rho_ref = 0.0;
210
211 // ML KEDF, sunliang added on 2022-11-07
212 bool of_ml_gene_data = false;
213 // device
214 std::string of_ml_device = "cpu";
215 int of_ml_feg = 0;
216 // kernel
218 std::vector<int> of_ml_kernel = {1};
219 std::vector<double> of_ml_kernel_scaling
220 = {1.0};
221 std::vector<double> of_ml_yukawa_alpha = {1.0};
222 std::vector<std::string> of_ml_kernel_file = {"none"};
223 // semi-local descriptors
224 bool of_ml_gamma = false;
225 bool of_ml_p = false;
226 bool of_ml_q = false;
227 bool of_ml_tanhp = false;
228 bool of_ml_tanhq = false;
229 double of_ml_chi_p = 1.0;
230 double of_ml_chi_q = 1.0;
231 // non-local descriptors
232 // of_ml_gammanl should be a vector of bool, but here we use a vector of int for convinience
233 std::vector<int> of_ml_gammanl = {0};
234 std::vector<int> of_ml_pnl = {0};
235 std::vector<int> of_ml_qnl = {0};
236 std::vector<int> of_ml_xi = {0};
237 std::vector<int> of_ml_tanhxi = {0};
238 std::vector<int> of_ml_tanhxi_nl = {0};
239 std::vector<int> of_ml_tanh_pnl = {0};
240 std::vector<int> of_ml_tanh_qnl = {0};
241 std::vector<int> of_ml_tanhp_nl = {0};
242 std::vector<int> of_ml_tanhq_nl = {0};
243 std::vector<double> of_ml_chi_xi = {1.0};
244 std::vector<double> of_ml_chi_pnl = {1.0};
245 std::vector<double> of_ml_chi_qnl = {1.0};
246 bool of_ml_local_test = false;
247
248 // ============== #Parameters (7.stochastic DFT) ===========================
249 int method_sto = 2;
251 int npart_sto = 1;
252 int nbands_sto = 256;
253 int nche_sto = 100;
255 double emin_sto = 0;
256 double emax_sto = 0;
257 int seed_sto = 0;
258 double initsto_ecut = 0.0;
259 int initsto_freq = 0;
260
261 // ============== #Parameters (8.DeepKS) ===========================
262 //==========================================================
263 // DeepKS -- added by caoyu and mohan
264 //==========================================================
269 bool deepks_scf = false;
272 std::vector<int> deepks_band_range = {-1, 0};
274 bool deepks_equiv = false;
275 bool deepks_out_unittest = false;
277 std::string deepks_model = "None";
278
280 std::string bessel_descriptor_ecut = "default";
285
286 // ============== #Parameters (9.rt-tddft) ===========================
287 double td_dt = -1.0;
288 int estep_per_md = 1;
289 bool td_vext = false;
290 // std::string td_vext_dire = "1"; ///< vext direction
291 std::vector<int> td_vext_dire = {1};
292
293 bool init_vecpot_file = false;
294 double td_print_eij = -1.0;
295 int td_edm = 0;
296 int propagator = 0;
297 int td_stype = 0;
298 std::string td_ttype = "0";
303 int td_tstart = 1;
304 int td_tend = 1000;
305
308 double td_lcut1 = 0.05;
309 double td_lcut2 = 0.95;
310
313 std::string td_gauss_freq = "22.13";
314 std::string td_gauss_phase = "0.0";
315 std::string td_gauss_sigma = "30.0";
316 std::string td_gauss_t0 = "100.0";
317 std::string td_gauss_amp = "0.25";
318
320 std::string td_trape_freq = "1.60";
321 // Trapezoidal
322 std::string td_trape_phase = "0.0";
323 std::string td_trape_t1 = "1875.0";
324 std::string td_trape_t2 = "5625.0";
325 std::string td_trape_t3 = "7500.0";
326 std::string td_trape_amp = "2.74"; // V/A
327
328 // Trigonometric
329 std::string td_trigo_freq1 = "1.164656"; // time(fs)^-1
330 std::string td_trigo_freq2 = "0.029116"; // time(fs)^-1
331 std::string td_trigo_phase1 = "0.0";
332 std::string td_trigo_phase2 = "0.0";
333 std::string td_trigo_amp = "2.74"; // V/A
334
335 // Heaviside
336 std::string td_heavi_t0 = "100.0";
337 std::string td_heavi_amp = "1.0"; // V/A
338
339 bool ocp = false;
340 // std::string ocp_set = "";
341 std::vector<double> ocp_kb = {};
342
343 // ============== #Parameters (10.lr-tddft) ===========================
344 int lr_nstates = 1;
345 std::vector<std::string> lr_init_xc_kernel = {};
346 int nocc = -1;
347 int nvirt = 1;
348 std::string xc_kernel = "LDA";
349 std::string lr_solver = "dav";
350 double lr_thr = 1e-2;
351 bool out_wfc_lr = false;
352 bool lr_unrestricted = false;
353 std::vector<double> abs_wavelen_range = {};
354 double abs_broadening = 0.01;
355 std::string abs_gauge
356 = "length";
357 std::string ri_hartree_benchmark = "none";
359 std::vector<int> aims_nbasis
360 = {};
361 // ============== #Parameters (11.Output) ===========================
362 bool out_stru = false;
364 int out_freq_ion = 0;
366 std::vector<int> out_chg = {0, 3};
367 std::vector<int> out_xc_r = {-1, 3};
368 int out_pot = 0;
369 int out_wfc_pw = 0;
370 std::vector<int> out_band = {0, 8};
371 int out_dos = 0;
372 std::vector<int> out_ldos = {0, 3};
373 bool out_mul = false;
374 bool out_proj_band = false;
375 std::string out_level = "ie";
376 bool out_dmk = false;
377 bool out_dmr = false;
378 bool out_bandgap = false;
379 std::vector<int> out_mat_hs = {0, 8};
380 std::vector<int> out_mat_tk = {0, 8};
381 std::vector<int> out_mat_l = {0, 8};
382 bool out_mat_hs2 = false;
384 bool out_mat_dh = false;
385 bool out_mat_ds = false;
386 bool out_mat_xc = false;
388 bool out_mat_xc2 = false;
389 bool out_eband_terms = false;
391 bool out_app_flag = true;
393 int out_ndigits = 8;
394 bool out_mat_t = false;
395 bool out_element_info = false;
396 bool out_mat_r = false;
397 int out_wfc_lcao = 0;
398 bool out_dipole = false;
399 bool out_efield = false;
400 bool out_current = false;
401 bool out_current_k = false;
402 bool out_vecpot = false;
403 bool restart_save = false;
404 bool rpa = false;
405 std::vector<int> out_pchg = {};
406 std::vector<int> out_wfc_norm = {};
407 std::vector<int> out_wfc_re_im = {};
408 bool if_separate_k = false;
409 std::vector<int> out_elf = {0, 3};
410 std::vector<int> cal_symm_repr = {0, 3};
411
412 // ============== #Parameters (12.Postprocess) ===========================
413 double dos_emin_ev = -15.0;
414 double dos_emax_ev = 15.0;
415 double dos_edelta_ev = 0.01;
416 double dos_scale = 0.01;
417 double dos_sigma = 0.07;
418 int dos_nche = 100;
419 std::vector<double> stm_bias = {1.0, 0.1, 1};
420 std::vector<double> ldos_line
421 = {0.0,
422 0.0,
423 0.0,
424 0.0,
425 0.0,
426 1.0,
427 100};
428
429 bool cal_cond = false;
430 double cond_che_thr = 1e-8;
432 double cond_dw = 0.1;
433 double cond_wcut = 10;
434 double cond_dt = 0.02;
435 int cond_dtbatch = 0;
436 int cond_smear = 1;
437 double cond_fwhm = 0.4;
438 bool cond_nonlocal = true;
439
440 bool berry_phase = false;
441 int gdir = 3;
443
447 bool towannier90 = false;
449 std::string nnkpfile = "seedname.nnkp";
451 std::string wannier_spin = "up";
454 bool out_wannier_mmn = true;
455 bool out_wannier_amn = true;
456 bool out_wannier_unk = false;
457 bool out_wannier_eig = true;
459
460 // ============== #Parameters (13.Model) ===========================
461 // ==========================================================
462 // efield and dipole correction
463 // Yu Liu add 2022-05-18
464 // ==========================================================
465 bool efield_flag = false;
466 bool dip_cor_flag = false;
467 int efield_dir = 2;
468 double efield_pos_max = -1;
470 double efield_pos_dec = -1;
471 double efield_amp = 0;
472
473 // ==========================================================
474 // gatefield (compensating charge)
475 // Yu Liu add 2022-09-13
476 // ==========================================================
477 bool gate_flag = false;
478 double zgate = 0.5;
479 bool block = false;
480 double block_down = 0.45;
481 double block_up = 0.55;
482 double block_height = 0.1;
483
484 // implicit solvation model Menglin Sun added on 2022-04-04
485 bool imp_sol = false;
487 double eb_k = 80;
488 double tau = 1.0798e-05;
489 double sigma_k = 0.6;
490 double nc_k = 0.00037;
491
492 // ============== #Parameters (14.vdW Correction) ===========================
493 // ==========================================================
494 // vdw
495 // Peize Lin add 2014-03-31, jiyy update 2019-08-01
496 // ==========================================================
497 std::string vdw_method = "none";
498 std::string vdw_s6 = "default";
499 std::string vdw_s8 = "default";
500 std::string vdw_a1 = "default";
501 std::string vdw_a2 = "default";
502 double vdw_d = 20.0;
503 bool vdw_abc = false;
504 std::string vdw_C6_file = "default";
505 std::string vdw_C6_unit = "Jnm6/mol";
506 std::string vdw_R0_file = "default";
507 std::string vdw_R0_unit = "A";
508 std::string vdw_cutoff_type = "radius";
510 std::string vdw_cutoff_radius = "default";
511 std::string vdw_radius_unit = "Bohr";
512 double vdw_cn_thr = 40.0;
513 std::string vdw_cn_thr_unit = "Bohr";
515
516 // ============== #Parameters (15.exx) ====================
517 // ==========================================================
518 // exx
519 // Peize Lin add 2018-06-20
520 // ==========================================================
521 std::vector<std::string> exx_fock_alpha = {"default"};
522 std::vector<std::string> exx_fock_lambda = {"default"};
524 std::vector<std::string> exx_erfc_alpha = {"default"};
525 std::vector<std::string> exx_erfc_omega = {"default"};
526 bool exx_separate_loop = true;
528 std::string exx_singularity_correction = "default";
529 int exx_hybrid_step = 100;
531 double exx_mixing_beta = 1.0;
532 std::string exx_real_number = "default";
533 double exx_pca_threshold = 0.0001;
534 double exx_c_threshold = 0.0001;
535 double exx_v_threshold = 0.1;
536 double exx_dm_threshold = 0.0001;
537 double exx_c_grad_threshold = 0.0001;
538 double exx_v_grad_threshold = 0.1;
539 double exx_c_grad_r_threshold = 0.0001;
541 std::string exx_ccp_rmesh_times = "default";
544 double exx_opt_orb_ecut = 0.0;
548 = true;
549 double rpa_ccp_rmesh_times = 10.0;
551 bool out_ri_cv = false;
552 // ============== #Parameters (16.dft+u) ======================
553 // DFT+U Xin Qu added on 2020-10-29
554 int dft_plus_u = 0;
555 bool dft_plus_dmft = false;
556 bool yukawa_potential = false;
557 double yukawa_lambda = -1.0;
558 double uramping_eV = -1.0;
559 int omc = 0;
560 double onsite_radius = 0.0;
561 std::vector<double> hubbard_u_eV = {};
562 std::vector<int> orbital_corr = {};
564
565 // ============== #Parameters (17.non-collinear spin-constrained DFT) =========
570 bool sc_mag_switch = false;
572 bool decay_grad_switch = false;
574 double sc_thr = 1e-06;
575 int nsc = 100;
576 int nsc_min = 2;
577 int sc_scf_nmin = 2;
578 double alpha_trial = 0.01;
579 double sccut = 3.0;
580 double sc_scf_thr = 1e-3;
581 double sc_drop_thr = 1e-3;
582
583 // ============== #Parameters (18.Quasiatomic Orbital analysis) =========
587 bool qo_switch = false;
588 std::string qo_basis = "szv";
590 double qo_thr = 1e-06;
591 std::vector<std::string> qo_strategy = {};
592 std::vector<double> qo_screening_coeff = {};
593
594 // ============== #Parameters (19.PEXSI) =====================
595 int pexsi_npole = 40;
596 bool pexsi_inertia = true;
597 int pexsi_nmax = 80;
598 bool pexsi_comm = true;
599 bool pexsi_storage = true;
602 int pexsi_nproc = 1;
603 bool pexsi_symm = true;
604 bool pexsi_trans = false;
607 double pexsi_temp = 0.015;
608 double pexsi_gap = 0;
609 double pexsi_delta_e = 20.0;
610 double pexsi_mu_lower = -10;
611 double pexsi_mu_upper = 10;
612 double pexsi_mu = 0.0;
613 double pexsi_mu_thr = 0.05;
614 double pexsi_mu_expand = 0.3;
615 double pexsi_mu_guard = 0.2;
616 double pexsi_elec_thr = 0.001;
617 double pexsi_zero_thr = 1e-10;
618
619 // ============== #Parameters (20.Test) ====================
620 bool out_alllog = false;
621 int nurse = 0;
622 bool t_in_h = true;
623 bool vl_in_h = true;
624 bool vnl_in_h = true;
625 bool vh_in_h = true;
626 bool vion_in_h = true;
628 bool test_force = false;
629 bool test_stress = false;
630 bool test_skip_ewald = false;
631 int test_atom_input = false;
632 // int test_symmetry = false; ///< variables for test_lattice only
633 int test_wf = 0;
634 int test_grid = false;
635 int test_charge = false;
636 int test_energy = false;
637 int test_gridt = false;
638 int test_pseudo_cell = false;
639 int test_pp = 0;
640 int test_relax_method = false;
641 int test_deconstructor = false;
642
643 // ============== #Parameters (21.RDMFT) =====================
644 // RDMFT jghan added on 2024-07-06
645 bool rdmft = false; // rdmft, reduced density matrix funcional theory
646 double rdmft_power_alpha = 0.656; // the alpha parameter of power-functional, g(occ_number) = occ_number^alpha
647 // double rdmft_wp22_omega; // the omega parameter of wp22-functional = exx_erfc_omega
648
649 // ============== #Parameters (22.EXX PW) =====================
650 // EXX for planewave basis, rhx0820 2025-03-10
651 bool exxace = true; // exxace, exact exchange for planewave basis, https://doi.org/10.1021/acs.jctc.6b00092
652 bool exx_gamma_extrapolation = true; // gamma point extrapolation for exx, https://doi.org/10.1103/PhysRevB.79.205114
653
654 // ==== #Parameters (23.XC external parameterization) ========
655 /*
656 * the following two sets of parameters are for the XC parameterization.
657 * The first element should be the LibXC id, to assign the analytical
658 * form of the eXchange and Correlation part of the functional.
659 *
660 * Starting from the second parameter, the parameters are the coefficients
661 * of the functional. For example the M06-L functional, one should refer
662 * to the source file (source code of LibXC)
663 *
664 * src/mgga_x_m06l.c
665 *
666 * the implementation can be found in the file
667 *
668 * src/maple2c/mgga_exc/mgga_x_m06l.c.
669 *
670 * There are 18 parameters for the exchange part, so the whole length of
671 * the xc_exch_ext should be 19. (MGGA_X_M06L, id = 203)
672 *
673 * Likewise, the correlation part can be found in corresponding files.
674 *
675 * PBE functional is used as the default functional for XCPNet.
676 */
677 // src/gga_x_pbe.c
678 std::vector<double> xc_exch_ext = {
679 101, 0.8040, 0.2195149727645171};
680 // src/gga_c_pbe.c
681 std::vector<double> xc_corr_ext = {
682 130, 0.06672455060314922, 0.031090690869654895034, 1.00000};
683};
684#endif
3 elements vector
Definition vector3.h:22
Reduced Density Matrix Functional Theory (RDMFT)
Definition rdmft.cpp:24
Definition input_parameter.h:12
bool noncolin
using non-collinear-spin
Definition input_parameter.h:125
double lcao_dr
dr used in two center integral
Definition input_parameter.h:133
bool out_alllog
output all logs.
Definition input_parameter.h:620
std::string td_trigo_phase1
Definition input_parameter.h:331
double relax_bfgs_w2
wolfe condition 2
Definition input_parameter.h:165
double exx_opt_orb_tolerence
Definition input_parameter.h:545
std::string ri_hartree_benchmark
Definition input_parameter.h:357
bool test_skip_ewald
variables for test only
Definition input_parameter.h:630
std::vector< int > of_ml_tanhxi_nl
Descriptor: tanhxi_nl = int{tanhxi(r') * w(r-r') dr'}.
Definition input_parameter.h:238
bool mixing_tau
whether to mix tau in mgga
Definition input_parameter.h:109
bool relax
allow relaxation along the specific direction
Definition input_parameter.h:153
int deepks_v_delta
for v_delta label. xuan added
Definition input_parameter.h:273
int nocc
the number of occupied orbitals to form the 2-particle basis
Definition input_parameter.h:346
int nurse
used for debug.
Definition input_parameter.h:621
double erf_height
the height of the energy step for reciprocal vectors
Definition input_parameter.h:44
double lcao_ecut
ecut of two center integral
Definition input_parameter.h:131
double bessel_descriptor_tolerence
tolerance for spherical bessel root
Definition input_parameter.h:281
bool out_mul
qifeng add 2019-9-10
Definition input_parameter.h:373
std::string relax_method
methods to move_ion: sd, bfgs, cg...
Definition input_parameter.h:151
double td_lcut2
Definition input_parameter.h:309
double emin_sto
Emin to normalize H.
Definition input_parameter.h:255
std::string td_heavi_t0
Definition input_parameter.h:336
double alpha_trial
initial trial step size for lambda in eV/uB^2
Definition input_parameter.h:578
bool out_wannier_amn
output .amn file or not
Definition input_parameter.h:455
int out_interval
Definition input_parameter.h:390
std::vector< double > abs_wavelen_range
the range of wavelength(nm) to output the absorption spectrum
Definition input_parameter.h:353
int nvirt
the number of virtual orbitals to form the 2-particle basis (nocc + nvirt <= nbands)
Definition input_parameter.h:347
std::string td_ttype
Definition input_parameter.h:298
std::vector< std::string > exx_erfc_omega
range-separation parameter in HSE functional
Definition input_parameter.h:525
double block_height
height of the block
Definition input_parameter.h:482
double tau
the effective surface tension parameter
Definition input_parameter.h:488
double cond_che_thr
Definition input_parameter.h:430
std::string td_trigo_freq2
Definition input_parameter.h:330
bool bessel_nao_smooth
spherical bessel smooth or not
Definition input_parameter.h:142
std::vector< int > of_ml_tanh_qnl
Descriptor: tanh_qnl = tanh(chi_qnl * qnl)
Definition input_parameter.h:240
std::string latname
lattice name
Definition input_parameter.h:35
std::vector< int > out_wfc_norm
specify the bands to be calculated for norm of wfc
Definition input_parameter.h:406
double lcao_rmax
rmax(a.u.) to make table.
Definition input_parameter.h:134
std::string ks_solver
xiaohui add 2013-09-01
Definition input_parameter.h:73
std::string calculation
Definition input_parameter.h:19
double efield_pos_dec
zone in the unit cell where the saw-like potential decreases
Definition input_parameter.h:470
bool of_ml_gene_data
Generate training data or not.
Definition input_parameter.h:212
int fft_mode
fftw mode 0: estimate, 1: measure, 2: patient, 3: exhaustive
Definition input_parameter.h:46
double mixing_restart
Definition input_parameter.h:102
std::vector< int > orbital_corr
Definition input_parameter.h:562
bool fixed_ibrav
Definition input_parameter.h:170
bool mixing_dmr
whether to mix real space density matrix
Definition input_parameter.h:111
int nbspline
the order of B-spline basis(>=0) if it is -1 (default)
Definition input_parameter.h:65
int seed_sto
random seed for sDFT
Definition input_parameter.h:257
double of_tolp
Definition input_parameter.h:189
double dos_sigma
pengfei 2014-10-13
Definition input_parameter.h:417
std::string of_kinetic
Kinetic energy functional, such as TF, VW, WT, TF+.
Definition input_parameter.h:183
bool fixed_atoms
whether to fix atoms during vc-relax
Definition input_parameter.h:172
std::vector< std::string > exx_fock_alpha
fraction of Fock exchange 1/r in hybrid functionals
Definition input_parameter.h:521
bool cal_syns
calculate asynchronous S matrix to output
Definition input_parameter.h:178
double cond_wcut
cutoff \omega for conductivities
Definition input_parameter.h:433
int td_tend
Definition input_parameter.h:304
std::string td_trigo_phase2
Definition input_parameter.h:332
int gdir
Definition input_parameter.h:441
std::vector< double > of_ml_chi_xi
Hyperparameter: tanhpxi = tanh(chi_xi * xi)
Definition input_parameter.h:243
int pexsi_npole
Definition input_parameter.h:595
double onsite_radius
radius of the sphere for onsite projection (Bohr)
Definition input_parameter.h:560
double pseudo_rcut
cut-off radius for calculating msh
Definition input_parameter.h:81
bool pexsi_trans
Definition input_parameter.h:604
int nz
three dimension of FFT wavefunc
Definition input_parameter.h:39
bool exx_symmetry_realspace
whether to reduce the real-space sector in when using symmetry=1 in EXX calculation
Definition input_parameter.h:548
bool test_force
test the force.
Definition input_parameter.h:628
int cond_dtbatch
exp(iH*dt*cond_dtbatch) is expanded with Chebyshev expansion.
Definition input_parameter.h:435
int by
Definition input_parameter.h:136
double erf_ecut
the value of the constant energy cutoff
Definition input_parameter.h:43
bool out_mat_t
Definition input_parameter.h:394
double lr_thr
convergence threshold of the LR-TDDFT eigensolver
Definition input_parameter.h:350
bool out_mat_hs2
Definition input_parameter.h:382
double yukawa_lambda
default: -1.0, which means we calculate lambda
Definition input_parameter.h:557
std::string symmetry
Definition input_parameter.h:27
double pexsi_mu_expand
Definition input_parameter.h:614
int out_pot
yes or no
Definition input_parameter.h:368
double exx_pca_threshold
threshold to screen on-site ABFs in exx
Definition input_parameter.h:533
std::string lr_solver
the eigensolver for LR-TDDFT
Definition input_parameter.h:349
std::string td_heavi_amp
Definition input_parameter.h:337
int td_edm
0: new edm method 1: old edm method
Definition input_parameter.h:295
bool of_ml_p
Descriptor: p = |nabla rho|^2 / [2 (3 pi^2)^(1/3) rho^(4/3)]^2.
Definition input_parameter.h:225
int pexsi_nmax
Definition input_parameter.h:597
bool out_mat_ds
Definition input_parameter.h:385
double mixing_gg0_mag
Definition input_parameter.h:106
bool out_dipole
output the dipole or not
Definition input_parameter.h:398
bool deepks_scf
Definition input_parameter.h:269
int nstream
Number of streams in CUDA as per input data.
Definition input_parameter.h:138
std::string orbital_dir
directory of orbital file
Definition input_parameter.h:59
std::string out_level
control the output information.
Definition input_parameter.h:375
std::string read_file_dir
directory of files for reading
Definition input_parameter.h:60
int lr_nstates
the number of 2-particle states to be solved
Definition input_parameter.h:344
double cell_factor
LiuXh add 20180619.
Definition input_parameter.h:42
std::vector< int > out_xc_r
output xc(r). -1: no; >=0: output the order of xc(r)
Definition input_parameter.h:367
double pexsi_mu_upper
Definition input_parameter.h:611
bool block
add a block potential or not
Definition input_parameter.h:479
int bessel_descriptor_lmax
lmax used in descriptor
Definition input_parameter.h:279
int efield_dir
the direction of the electric field or dipole correction
Definition input_parameter.h:467
std::string init_wfc
"file","atomic","random"
Definition input_parameter.h:47
std::vector< int > out_mat_l
output L matrix in local basis.
Definition input_parameter.h:381
std::vector< int > of_ml_tanh_pnl
Descriptor: tanh_pnl = tanh(chi_pnl * pnl)
Definition input_parameter.h:239
int method_sto
Definition input_parameter.h:249
bool pseudo_mesh
Definition input_parameter.h:82
std::vector< double > of_ml_kernel_scaling
Scaling parameter of kernel, w(r-r') = lambda^3 * w(lambda (r-r')), lambda = 1/scaling.
Definition input_parameter.h:220
bool out_wannier_mmn
add by renxi for wannier90: output .mmn file or not
Definition input_parameter.h:454
double relax_bfgs_w1
wolfe condition 1
Definition input_parameter.h:164
std::string vdw_R0_unit
unit of R0, A or Bohr
Definition input_parameter.h:507
bool out_bandgap
QO added for bandgap printing.
Definition input_parameter.h:378
std::string td_trigo_freq1
Definition input_parameter.h:329
bool out_dmk
output density matrix DM(k)
Definition input_parameter.h:376
std::vector< double > of_ml_chi_qnl
Hyperparameter: tanh_qnl = tanh(chi_qnl * qnl)
Definition input_parameter.h:245
std::string td_trape_t2
Definition input_parameter.h:324
bool of_read_kernel
Definition input_parameter.h:204
bool vion_in_h
Definition input_parameter.h:626
std::vector< double > hubbard_u_eV
Hubbard Coulomb interaction parameter U(ev)
Definition input_parameter.h:561
bool td_vext
add extern potential or not
Definition input_parameter.h:289
int test_grid
variables for test_grid only
Definition input_parameter.h:634
int scf_thr_type
type of the criterion of scf_thr, 1: reci drho, 2: real drho
Definition input_parameter.h:117
double cond_dt
dt to integrate conductivities
Definition input_parameter.h:434
double abs_broadening
the broadening (eta) for LR-TDDFT absorption spectrum
Definition input_parameter.h:354
std::string td_gauss_phase
Definition input_parameter.h:314
bool out_vecpot
output the vector potential or not
Definition input_parameter.h:402
bool qo_switch
0: no QO analysis; 1: QO analysis
Definition input_parameter.h:587
bool out_app_flag
Definition input_parameter.h:391
bool pexsi_storage
Definition input_parameter.h:599
double exx_c_grad_r_threshold
threshold to screen nabla C * R matrix in exx
Definition input_parameter.h:539
double relax_bfgs_init
initial move
Definition input_parameter.h:168
bool restart_save
restart //Peize Lin add 2020-04-04
Definition input_parameter.h:403
int out_wfc_lcao
output the wave functions in local basis.
Definition input_parameter.h:397
double of_tf_weight
weight of TF KEDF
Definition input_parameter.h:191
std::vector< int > of_ml_qnl
Descriptor: qnl = int{q(r') * w(r-r') dr'}.
Definition input_parameter.h:235
std::string td_trape_amp
Definition input_parameter.h:326
int deepks_out_freq_elec
Definition input_parameter.h:267
std::vector< double > of_ml_yukawa_alpha
Parameter alpha of yukawa kernel.
Definition input_parameter.h:221
int diago_cg_prec
mohan add 2012-03-31
Definition input_parameter.h:89
bool out_element_info
output information of all elements
Definition input_parameter.h:395
bool out_wfc_lr
whether to output the eigenvectors (excitation amplitudes) in the particle-hole basis
Definition input_parameter.h:351
std::string vdw_cutoff_radius
radius cutoff for periodic structure
Definition input_parameter.h:510
bool symmetry_autoclose
Definition input_parameter.h:29
bool efield_flag
add electric field
Definition input_parameter.h:465
int dft_plus_u
0: standard DFT calculation (default)
Definition input_parameter.h:554
int pexsi_nproc
Definition input_parameter.h:602
bool of_ml_gamma
Descriptor: gamma = (rho / rho0)^(1/3)
Definition input_parameter.h:224
std::string td_trape_t1
Definition input_parameter.h:323
std::string chg_extrap
xiaohui modify 2015-02-01
Definition input_parameter.h:51
int nx
Definition input_parameter.h:39
std::string td_gauss_sigma
time(fs)
Definition input_parameter.h:315
int pexsi_row_ordering
Definition input_parameter.h:601
std::string exx_real_number
exx calculated in real or complex
Definition input_parameter.h:532
std::vector< double > ldos_line
start and end point of the line (direct coordinates) and number of points
Definition input_parameter.h:421
bool berry_phase
berry phase calculation: calculate berry phase or not
Definition input_parameter.h:440
std::string td_trape_phase
Definition input_parameter.h:322
int mixing_ndim
used in Broyden method
Definition input_parameter.h:101
std::vector< int > out_pchg
specify the bands to be calculated for partial charge
Definition input_parameter.h:405
bool if_separate_k
whether to write partial charge for all k-points to individual files or merge them
Definition input_parameter.h:408
bool cal_cond
calculate electronic conductivities
Definition input_parameter.h:429
int bx
Definition input_parameter.h:136
double exx_mixing_beta
mixing_beta for outer-loop when exx_separate_loop=1
Definition input_parameter.h:531
bool ocp
Definition input_parameter.h:339
bool imp_sol
Definition input_parameter.h:485
std::string vdw_s8
scale parameter of d3_0/d3_bj
Definition input_parameter.h:499
bool out_eband_terms
output the band energy terms separately
Definition input_parameter.h:389
std::string init_chg
"file","atomic"
Definition input_parameter.h:49
double relax_cg_thr
threshold when cg to bfgs, pengfei add 2011-08-15
Definition input_parameter.h:156
int pexsi_ordering
Definition input_parameter.h:600
bool init_vel
read velocity from STRU or not liuyu 2021-07-14
Definition input_parameter.h:52
double xc_temperature
only relevant if finite temperature functional is used
Definition input_parameter.h:80
int out_wfc_pw
0: no; 1: txt; 2: dat
Definition input_parameter.h:369
bool dip_cor_flag
dipole correction
Definition input_parameter.h:466
double vdw_d
damping parameter of d2
Definition input_parameter.h:502
MD_para mdp
Definition input_parameter.h:175
double cond_fwhm
FWHM for conductivities.
Definition input_parameter.h:437
double force_zero_out
invalid force threshold, mohan add 2011-04-17
Definition input_parameter.h:159
bool of_ml_tanhq
Descriptor: tanhq = tanh(chi_q * q)
Definition input_parameter.h:228
std::vector< std::string > exx_fock_lambda
Definition input_parameter.h:522
bool out_stru
outut stru file each ion step
Definition input_parameter.h:362
int estep_per_md
number of electronic steps per MD step
Definition input_parameter.h:288
double press2
Definition input_parameter.h:162
double mixing_gg0_min
Definition input_parameter.h:107
int out_ndigits
Assuming 8 digits precision is needed for matrices output.
Definition input_parameter.h:393
std::vector< double > ocp_kb
OCP kb values.
Definition input_parameter.h:341
bool relax_new
Definition input_parameter.h:152
double ecutwfc
energy cutoff for wavefunctions
Definition input_parameter.h:36
int bndpar
parallel for stochastic/deterministic bands
Definition input_parameter.h:34
int ndz
three dimension of FFT smooth charge density
Definition input_parameter.h:40
bool deepks_out_unittest
Definition input_parameter.h:275
std::vector< int > out_mat_hs
output H matrix and S matrix in local basis.
Definition input_parameter.h:379
int of_ml_feg
The Free Electron Gas limit: 0: no, 3: yes.
Definition input_parameter.h:215
double force_thr_ev
threshold of force in unit (eV/Angstrom)
Definition input_parameter.h:158
std::string vdw_C6_file
filename of C6
Definition input_parameter.h:504
int kpar
ecch pool is for one k point
Definition input_parameter.h:33
double scf_os_thr
drho threshold for oscillation
Definition input_parameter.h:120
std::string vdw_cutoff_type
Definition input_parameter.h:508
std::vector< int > td_vext_dire
vector of vext direction
Definition input_parameter.h:291
int out_freq_elec
the frequency of electronic iter to output charge and wavefunction
Definition input_parameter.h:363
std::vector< int > of_ml_pnl
Descriptor: pnl = int{p(r') * w(r-r') dr'}.
Definition input_parameter.h:234
bool use_k_continuity
whether to use k-point continuity for initializing wave functions
Definition input_parameter.h:91
std::vector< int > of_ml_tanhxi
Descriptor: tanhxi = tanh(chi_xi * xi)
Definition input_parameter.h:237
double erf_sigma
the width of the energy step for reciprocal vectors
Definition input_parameter.h:45
double ref_cell_factor
Definition input_parameter.h:176
double of_lkt_a
parameter a of LKT KEDF
Definition input_parameter.h:199
int pexsi_nproc_pole
Definition input_parameter.h:606
double lcao_dk
delta k used in two center integral
Definition input_parameter.h:132
std::vector< int > of_ml_xi
Descriptor: xi = int{rho(r')^(1/3) * w(r-r') dr'} / rho^(1/3)
Definition input_parameter.h:236
std::string vdw_a1
damping parameter of d3_0/d3_bj
Definition input_parameter.h:500
double nc_k
the cut-off charge density
Definition input_parameter.h:490
int diag_subspace
Definition input_parameter.h:90
std::vector< double > xc_exch_ext
Definition input_parameter.h:678
std::string dft_functional
input DFT functional.
Definition input_parameter.h:79
int td_tstart
Definition input_parameter.h:303
double pw_diag_thr
used in cg method
Definition input_parameter.h:86
double pexsi_elec_thr
Definition input_parameter.h:616
double exx_c_grad_threshold
threshold to screen nabla C matrix in exx
Definition input_parameter.h:537
double ecutrho
energy cutoff for charge/potential
Definition input_parameter.h:37
double symmetry_prec
LiuXh add 2021-08-12, accuracy for symmetry.
Definition input_parameter.h:28
double td_print_eij
threshold to output Eij elements
Definition input_parameter.h:294
bool of_ml_tanhp
Descriptor: tanhp = tanh(chi_p * p)
Definition input_parameter.h:227
double relax_bfgs_rmax
trust radius max
Definition input_parameter.h:166
double cond_dw
d\omega for conductivities
Definition input_parameter.h:432
int elpa_num_thread
Number of threads need to use in elpa.
Definition input_parameter.h:137
bool out_current
output the current or not
Definition input_parameter.h:400
bool cal_force
calculate the force
Definition input_parameter.h:31
double pexsi_gap
Definition input_parameter.h:608
std::vector< int > of_ml_tanhq_nl
Descriptor: tanhq_nl = int{tanhq(r') * w(r-r') dr'}.
Definition input_parameter.h:242
double stress_thr
Pengfei Li 2017-11-01 ///<LiuXh update 20180515.
Definition input_parameter.h:160
std::string vdw_method
the method of calculating vdw (none; d2; d3_0; d3_bj)
Definition input_parameter.h:497
std::string vdw_s6
scale parameter of d2/d3_0/d3_bj
Definition input_parameter.h:498
double pexsi_mu
Definition input_parameter.h:612
int propagator
method of propagator
Definition input_parameter.h:296
double relax_bfgs_rmin
trust radius min
Definition input_parameter.h:167
bool out_wannier_unk
output UNK. file or not
Definition input_parameter.h:456
std::vector< std::string > qo_strategy
No specific values provided for qo_strategy.
Definition input_parameter.h:591
std::string td_trigo_amp
Definition input_parameter.h:333
double of_xwm_kappa
The parameter kappa of XWM KEDF.
Definition input_parameter.h:208
double search_radius
11.1
Definition input_parameter.h:135
bool t_in_h
calculate the T or not.
Definition input_parameter.h:622
double dos_scale
Definition input_parameter.h:416
int of_full_pw_dim
Definition input_parameter.h:202
std::string deepks_model
needed when deepks_scf=1
Definition input_parameter.h:277
std::vector< int > out_chg
output charge density. 0: no; 1: yes
Definition input_parameter.h:366
double initsto_ecut
maximum ecut to init stochastic bands
Definition input_parameter.h:258
bool out_wannier_eig
output .eig file or not
Definition input_parameter.h:457
std::string suffix
suffix of out put dir
Definition input_parameter.h:17
bool exx_gamma_extrapolation
Definition input_parameter.h:652
std::string td_gauss_t0
Definition input_parameter.h:316
double emax_sto
Emax to normalize H.
Definition input_parameter.h:256
double of_wt_rho0
set the average density of system, in Bohr^-3
Definition input_parameter.h:195
int ndy
Definition input_parameter.h:40
std::string xc_kernel
exchange correlation (XC) kernel for LR-TDDFT
Definition input_parameter.h:348
int test_relax_method
variables for test_relax_method only
Definition input_parameter.h:640
double rpa_ccp_rmesh_times
Definition input_parameter.h:549
double exx_v_grad_r_threshold
threshold to screen nabla V * R matrix in exx
Definition input_parameter.h:540
int exx_hybrid_step
Definition input_parameter.h:529
double vdw_cn_thr
radius cutoff for cn
Definition input_parameter.h:512
int deepks_out_labels
Definition input_parameter.h:265
int wannier_method
different implementation methods under Lcao basis set
Definition input_parameter.h:453
std::vector< int > deepks_band_range
the range of bands to calculate bandgap
Definition input_parameter.h:272
std::string vdw_C6_unit
unit of C6, Jnm6/mol or eVA6
Definition input_parameter.h:505
std::vector< int > out_ldos
ldos calculation
Definition input_parameter.h:372
double efield_pos_max
Definition input_parameter.h:468
int nspin
LDA ; LSDA ; non-linear spin.
Definition input_parameter.h:84
int ndx
Definition input_parameter.h:40
bool out_mat_xc
Definition input_parameter.h:386
double press1
Definition input_parameter.h:161
int mem_saver
1: save psi when nscf calculation.
Definition input_parameter.h:63
double sigma_k
the width of the diffuse cavity
Definition input_parameter.h:489
std::vector< double > kspacing
kspacing for k-point generation
Definition input_parameter.h:66
bool lr_unrestricted
whether to use the unrestricted construction for LR-TDDFT
Definition input_parameter.h:352
double relax_scale_force
Definition input_parameter.h:154
int test_atom_input
variables for test_atom_input only
Definition input_parameter.h:631
bool vdw_abc
third-order term?
Definition input_parameter.h:503
std::string nnkpfile
Definition input_parameter.h:449
int bz
big mesh ball. 0: auto set bx/by/bz
Definition input_parameter.h:136
double dos_emin_ev
Definition input_parameter.h:413
double of_ml_chi_p
Hyperparameter: tanhp = tanh(chi_p * p)
Definition input_parameter.h:229
int deepks_bandgap
for bandgap label. QO added 2021-12-15
Definition input_parameter.h:271
double rdmft_power_alpha
Definition input_parameter.h:646
double exx_dm_threshold
threshold to screen density matrix in exx
Definition input_parameter.h:536
int out_dos
dos calculation. mohan add 20090909
Definition input_parameter.h:371
std::string vdw_radius_unit
unit of radius cutoff for periodic structure
Definition input_parameter.h:511
bool diago_smooth_ethr
smooth ethr for iter methods
Definition input_parameter.h:87
int out_freq_ion
Definition input_parameter.h:364
std::vector< std::string > exx_erfc_alpha
fraction of exchange erfc(wr)/r in hybrid functionals
Definition input_parameter.h:524
double scf_thr
\sum |rhog_out - rhog_in |^2
Definition input_parameter.h:115
double bessel_nao_sigma
spherical bessel smearing_sigma
Definition input_parameter.h:143
std::string wannier_spin
Definition input_parameter.h:451
int test_gridt
variables for test_gridt only
Definition input_parameter.h:637
bool out_wannier_wvfn_formatted
output UNK. file in text format or in binary format
Definition input_parameter.h:458
std::string vdw_a2
damping parameter of d3_bj
Definition input_parameter.h:501
double of_xwm_rho_ref
The reference density of XWM KEDF.
Definition input_parameter.h:209
int test_wf
variables for test_wf only
Definition input_parameter.h:633
std::string precision
Definition input_parameter.h:70
bool test_stress
test the stress.
Definition input_parameter.h:629
bool out_ri_cv
Whether to output the coefficient tensor C and ABFs-representation Coulomb matrix V.
Definition input_parameter.h:551
bool exx_separate_loop
Definition input_parameter.h:526
double soc_lambda
The fraction of SOC based on scalar relativity (SR) of the pseudopotential.
Definition input_parameter.h:126
double nelec
total number of electrons
Definition input_parameter.h:76
int pw_diag_ndim
dimension of workspace for Davidson diagonalization
Definition input_parameter.h:88
int scf_os_ndim
number of old iterations used for oscillation detection
Definition input_parameter.h:121
double of_ml_chi_q
Hyperparameter: tanhq = tanh(chi_q * q)
Definition input_parameter.h:230
double pexsi_delta_e
Definition input_parameter.h:609
double exx_opt_orb_ecut
the cut-off of plane wave expansion for opt ABFs
Definition input_parameter.h:544
std::string pseudo_dir
directory of pseudopotential
Definition input_parameter.h:58
double press3
Definition input_parameter.h:163
std::string of_conv
Definition input_parameter.h:185
int test_deconstructor
variables for test_deconstructor only
Definition input_parameter.h:641
bool mixing_dftu
whether to mix locale in DFT+U
Definition input_parameter.h:110
int relax_nmax
number of max ionic iter
Definition input_parameter.h:155
double pexsi_mu_thr
Definition input_parameter.h:613
bool cal_stress
calculate the stress
Definition input_parameter.h:32
int pexsi_method
Definition input_parameter.h:605
bool scf_os_stop
whether to stop scf when oscillation is detected
Definition input_parameter.h:119
bool out_mat_dh
Definition input_parameter.h:384
double of_wt_beta
parameter beta of WT KEDF
Definition input_parameter.h:194
int td_stype
type of space domain 0 : length gauge 1: velocity gauge
Definition input_parameter.h:297
double mixing_angle
Definition input_parameter.h:108
bool pexsi_symm
Definition input_parameter.h:603
bool out_proj_band
projected band structure calculation jiyy add 2022-05-11
Definition input_parameter.h:374
std::string input_file
input file name
Definition input_parameter.h:54
double pexsi_zero_thr
Definition input_parameter.h:617
std::string td_gauss_amp
V/A.
Definition input_parameter.h:317
double pexsi_temp
Definition input_parameter.h:607
double scf_ene_thr
energy threshold for scf convergence, in eV
Definition input_parameter.h:116
bool out_mat_r
jingan add 2019-8-14, output r(R) matrix.
Definition input_parameter.h:396
double sccut
restriction of step size in eV/uB
Definition input_parameter.h:579
bool exxace
Definition input_parameter.h:651
std::string vdw_R0_file
filename of R0
Definition input_parameter.h:506
double td_lcut1
Definition input_parameter.h:308
int test_charge
variables for test_vloc only
Definition input_parameter.h:635
std::vector< double > bessel_nao_rcuts
No specific values provided for bessel_nao_rcuts.
Definition input_parameter.h:141
std::string of_ml_device
Run NN on GPU or CPU.
Definition input_parameter.h:214
int omc
the mode of occupation matrix control
Definition input_parameter.h:559
std::string qo_basis
Definition input_parameter.h:588
std::string of_method
optimization method, include cg1, cg2, tn (default), bfgs
Definition input_parameter.h:184
double of_wt_alpha
parameter alpha of WT KEDF
Definition input_parameter.h:193
std::string stru_file
Definition input_parameter.h:55
bool lspinorb
consider the spin-orbit interaction
Definition input_parameter.h:124
int nche_sto
Definition input_parameter.h:253
int nbands
number of bands
Definition input_parameter.h:75
double dos_emax_ev
Definition input_parameter.h:414
bool of_hold_rho0
Definition input_parameter.h:196
bool bessel_descriptor_smooth
spherical bessel smooth or not
Definition input_parameter.h:283
int npart_sto
for method_sto = 2, reduce memory
Definition input_parameter.h:251
int scf_nmax
number of max elec iter
Definition input_parameter.h:114
int ntype
number of atom types
Definition input_parameter.h:18
double smearing_sigma
Definition input_parameter.h:97
bool yukawa_potential
default: false
Definition input_parameter.h:556
std::vector< int > out_mat_tk
output T(k) matrix in local basis.
Definition input_parameter.h:380
std::string kpoint_file
file contains k-points – xiaohui modify 2015-02-01
Definition input_parameter.h:57
bool cond_nonlocal
if calculate nonlocal effects
Definition input_parameter.h:438
bool out_dmr
output density matrix DM(R)
Definition input_parameter.h:377
std::string td_trape_t3
Definition input_parameter.h:325
bool rpa
rpa calculation
Definition input_parameter.h:404
ModuleBase::Vector3< int > vdw_cutoff_period
periods of periodic structure
Definition input_parameter.h:514
int pw_diag_nmax
Definition input_parameter.h:85
double sc_thr
threshold for spin-constrained DFT in uB
Definition input_parameter.h:574
std::string wannier_card
input card for wannier functions.
Definition input_parameter.h:62
double mixing_beta_mag
Definition input_parameter.h:105
double dos_edelta_ev
Definition input_parameter.h:415
std::vector< std::string > of_ml_kernel_file
The file of TKK.
Definition input_parameter.h:222
bool pexsi_comm
Definition input_parameter.h:598
double force_thr
threshold of force in unit (Ry/Bohr)
Definition input_parameter.h:157
int nsc_min
minimum number of inner lambda loop
Definition input_parameter.h:576
std::vector< double > qo_screening_coeff
No specific values provided for qo_screening_coeff.
Definition input_parameter.h:592
bool vnl_in_h
calculate the vnl or not.
Definition input_parameter.h:624
double mixing_beta
0 : no_mixing
Definition input_parameter.h:100
double sc_scf_thr
minimum number of outer scf loop before initial lambda loop
Definition input_parameter.h:580
std::string td_trape_freq
time(fs)^-1
Definition input_parameter.h:320
std::string exx_ccp_rmesh_times
Definition input_parameter.h:541
double block_down
low bound of the block
Definition input_parameter.h:480
std::string exx_singularity_correction
set the scheme of Coulomb singularity correction
Definition input_parameter.h:528
bool vl_in_h
calculate the vloc or not.
Definition input_parameter.h:623
double exx_v_grad_threshold
threshold to screen nabla V matrix in exx
Definition input_parameter.h:538
std::vector< int > cal_symm_repr
output the symmetry representation matrix
Definition input_parameter.h:410
double zgate
position of charged plate
Definition input_parameter.h:478
std::string abs_gauge
whether to use length or velocity gauge to calculate the absorption spectrum in LR-TDDFT
Definition input_parameter.h:356
std::vector< double > xc_corr_ext
Definition input_parameter.h:681
bool out_current_k
output tddft current for all k points
Definition input_parameter.h:401
int dos_nche
orders of Chebyshev expansions for dos
Definition input_parameter.h:418
std::string smearing_method
Definition input_parameter.h:93
std::string basis_type
xiaohui add 2013-09-01, for structural adjustment
Definition input_parameter.h:74
std::string of_kernel_file
The name of WT kernel file.
Definition input_parameter.h:207
bool out_mat_xc2
output exchange-correlation matrix Vxc(R) in NAO representation.
Definition input_parameter.h:388
int nsc
maximum number of inner lambda loop
Definition input_parameter.h:575
double efield_amp
amplitude of the electric field
Definition input_parameter.h:471
bool vh_in_h
calculate the hartree potential or not
Definition input_parameter.h:625
bool gate_flag
compensating charge or not
Definition input_parameter.h:477
int of_ml_nkernel
Number of kernels.
Definition input_parameter.h:217
bool out_efield
output the efield or not
Definition input_parameter.h:399
std::string mixing_mode
"plain","broyden",...
Definition input_parameter.h:99
int cond_smear
smearing method for conductivities 1: Gaussian 2: Lorentzian
Definition input_parameter.h:436
std::string esolver_type
the energy solver: ksdft, sdft, ofdft, tddft, lj, dp
Definition input_parameter.h:22
double of_vw_weight
weight of vW KEDF
Definition input_parameter.h:192
double min_dist_coef
allowed minimum distance between two atoms
Definition input_parameter.h:67
bool dft_plus_dmft
true:DFT+DMFT; false: standard DFT calcullation(default)
Definition input_parameter.h:555
bool dm_to_rho
read density matrix from npz format and calculate charge density
Definition input_parameter.h:50
std::vector< int > of_ml_gammanl
Descriptor: gammanl = int{gamma(r') * w(r-r') dr'}.
Definition input_parameter.h:233
double nelec_delta
change in the number of total electrons
Definition input_parameter.h:77
std::vector< int > of_ml_kernel
Type of kernel, 1 for wt, 2 for yukawa, and 3 for TKK.
Definition input_parameter.h:218
int nbands_sto
number of stochastic bands //qianrui 2021-2-5
Definition input_parameter.h:252
bool decay_grad_switch
Definition input_parameter.h:572
int exx_opt_orb_lmax
the maximum l of the spherical Bessel functions for opt ABFs
Definition input_parameter.h:543
int sc_os_ndim
number of old iterations used for oscillation detection in Spin-Constrained DFT
Definition input_parameter.h:122
double bessel_nao_tolerence
tolerance for spherical bessel root
Definition input_parameter.h:140
std::string bessel_nao_ecut
energy cutoff for spherical bessel functions(Ry)
Definition input_parameter.h:139
std::vector< std::string > lr_init_xc_kernel
The method to initalize the xc kernel.
Definition input_parameter.h:345
double dmax
maximum displacement of all atoms in one step (bohr)
Definition input_parameter.h:179
int diago_proc
the number of procs used to diag. mohan add 2012-01-13
Definition input_parameter.h:64
int pw_seed
random seed for initializing wave functions
Definition input_parameter.h:48
double exx_v_threshold
threshold to screen C matrix in exx
Definition input_parameter.h:535
double mixing_gg0
used in kerker method
Definition input_parameter.h:104
std::vector< int > of_ml_tanhp_nl
Descriptor: tanhp_nl = int{tanhp(r') * w(r-r') dr'}.
Definition input_parameter.h:241
bool sc_mag_switch
Definition input_parameter.h:570
std::vector< int > aims_nbasis
the number of basis functions for each atom type used in FHI-aims (for benchmark)
Definition input_parameter.h:360
int nb2d
matrix 2d division.
Definition input_parameter.h:129
double bessel_descriptor_rcut
radial cutoff for spherical bessel functions(a.u.)
Definition input_parameter.h:282
double exx_c_threshold
threshold to screen C matrix in exx
Definition input_parameter.h:534
std::string fixed_axes
which axes are fixed
Definition input_parameter.h:169
std::vector< int > out_wfc_re_im
specify the bands to be calculated for real and imaginary parts of wfc
Definition input_parameter.h:407
bool init_vecpot_file
initialize the vector potential, though file or integral
Definition input_parameter.h:293
double sc_drop_thr
threshold for lambda-loop threshold cutoff in spin-constrained DFT
Definition input_parameter.h:581
bool of_ml_q
Descriptor: q = nabla^2 rho / [4 (3 pi^2)^(2/3) rho^(5/3)].
Definition input_parameter.h:226
bool of_full_pw
Definition input_parameter.h:200
int sc_scf_nmin
minimum number of outer scf loop before initial lambda loop
Definition input_parameter.h:577
std::string bessel_descriptor_ecut
energy cutoff for spherical bessel functions(Ry)
Definition input_parameter.h:280
double nupdown
Definition input_parameter.h:78
double td_dt
time step for propagation
Definition input_parameter.h:287
int ny
Definition input_parameter.h:39
bool of_ml_local_test
Test: read in the density, and output the F and Pauli potential.
Definition input_parameter.h:246
bool pexsi_inertia
Definition input_parameter.h:596
double pexsi_mu_lower
Definition input_parameter.h:610
bool restart_load
Definition input_parameter.h:61
double pexsi_mu_guard
Definition input_parameter.h:615
double block_up
high bound of the block
Definition input_parameter.h:481
int test_energy
variables for test_energy only
Definition input_parameter.h:636
std::vector< int > out_elf
output the electron localization function (ELF). 0: no; 1: yes
Definition input_parameter.h:409
double uramping_eV
U-Ramping method (eV)
Definition input_parameter.h:558
int test_pseudo_cell
variables for test_pseudo_cell only
Definition input_parameter.h:638
int initsto_freq
frequency to init stochastic orbitals when running md
Definition input_parameter.h:259
std::string device
Definition input_parameter.h:69
std::vector< int > out_band
band calculation pengfei 2014-10-13
Definition input_parameter.h:370
std::vector< double > stm_bias
bias voltage for STM (start value, step, number)
Definition input_parameter.h:419
std::string vdw_cn_thr_unit
unit of cn_thr, Bohr or Angstrom
Definition input_parameter.h:513
std::vector< double > of_ml_chi_pnl
Hyperparameter: tanh_pnl = tanh(chi_pnl * pnl)
Definition input_parameter.h:244
bool deepks_equiv
whether to use equivariant version of DeePKS
Definition input_parameter.h:274
std::string td_gauss_freq
time(fs)^-1
Definition input_parameter.h:313
bool towannier90
Definition input_parameter.h:447
double eb_k
the relative permittivity of the bulk solvent
Definition input_parameter.h:487
int lmaxmax
maximum of l channels used
Definition input_parameter.h:130
double of_tole
Definition input_parameter.h:187
bool gamma_only
for plane wave.
Definition input_parameter.h:113
double bessel_descriptor_sigma
spherical bessel smearing_sigma
Definition input_parameter.h:284
int test_pp
variables for test_pp only
Definition input_parameter.h:639
double qo_thr
Definition input_parameter.h:590
input parameters used in md
Definition md_parameter.h:12