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