|
ABACUS develop
Atomic-orbital Based Ab-initio Computation at UStc
|
#include <input_parameter.h>
Public Attributes | |
| std::string | suffix = "ABACUS" |
| suffix of out put dir | |
| int | ntype = 0 |
| number of atom types | |
| std::string | calculation = "scf" |
| std::string | esolver_type = "ksdft" |
| the energy solver: ksdft, sdft, ofdft, tddft, lj, dp | |
| std::string | symmetry = "default" |
| double | symmetry_prec = 1.0e-6 |
| LiuXh add 2021-08-12, accuracy for symmetry. | |
| bool | symmetry_autoclose = true |
| bool | cal_force = false |
| calculate the force | |
| bool | cal_stress = false |
| calculate the stress | |
| int | kpar = 1 |
| ecch pool is for one k point | |
| int | bndpar = 1 |
| parallel for stochastic/deterministic bands | |
| std::string | latname = "none" |
| lattice name | |
| double | ecutwfc = 0 |
| energy cutoff for wavefunctions | |
| double | ecutrho = 0 |
| energy cutoff for charge/potential | |
| int | nx = 0 |
| int | ny = 0 |
| int | nz = 0 |
| three dimension of FFT wavefunc | |
| int | ndx = 0 |
| int | ndy = 0 |
| int | ndz = 0 |
| three dimension of FFT smooth charge density | |
| double | cell_factor = 1.2 |
| LiuXh add 20180619. | |
| double | erf_ecut = 0 |
| the value of the constant energy cutoff | |
| double | erf_height = 0 |
| the height of the energy step for reciprocal vectors | |
| double | erf_sigma = 0.1 |
| the width of the energy step for reciprocal vectors | |
| int | fft_mode = 0 |
| fftw mode 0: estimate, 1: measure, 2: patient, 3: exhaustive | |
| std::string | init_wfc = "atomic" |
| "file","atomic","random" | |
| int | pw_seed = 0 |
| random seed for initializing wave functions | |
| std::string | init_chg = "atomic" |
| "file","atomic" | |
| bool | dm_to_rho = false |
| read density matrix from npz format and calculate charge density | |
| std::string | chg_extrap = "default" |
| xiaohui modify 2015-02-01 | |
| bool | init_vel = false |
| read velocity from STRU or not liuyu 2021-07-14 | |
| std::string | input_file = "INPUT" |
| input file name | |
| std::string | stru_file = "STRU" |
| std::string | kpoint_file = "KPT" |
| file contains k-points – xiaohui modify 2015-02-01 | |
| std::string | pseudo_dir = "" |
| directory of pseudopotential | |
| std::string | orbital_dir = "" |
| directory of orbital file | |
| std::string | read_file_dir = "auto" |
| directory of files for reading | |
| bool | restart_load = false |
| int | mem_saver = 0 |
| 1: save psi when nscf calculation. | |
| int | diago_proc = 0 |
| the number of procs used to diag. mohan add 2012-01-13 | |
| int | nbspline = -1 |
| the order of B-spline basis(>=0) if it is -1 (default) | |
| std::vector< double > | kspacing = {0.0, 0.0, 0.0} |
| kspacing for k-point generation | |
| double | min_dist_coef = 0.2 |
| allowed minimum distance between two atoms | |
| std::string | device = "auto" |
| std::string | precision = "double" |
| bool | timer_enable_nvtx = false |
| std::string | ks_solver = "default" |
| xiaohui add 2013-09-01 | |
| std::string | basis_type = "pw" |
| xiaohui add 2013-09-01, for structural adjustment | |
| int | nbands = 0 |
| number of bands | |
| double | nelec = 0.0 |
| total number of electrons | |
| double | nelec_delta = 0.0 |
| change in the number of total electrons | |
| double | nupdown = 0.0 |
| std::string | dft_functional = "default" |
| input DFT functional. | |
| double | xc_temperature = 0.0 |
| only relevant if finite temperature functional is used | |
| double | pseudo_rcut = 15.0 |
| cut-off radius for calculating msh | |
| bool | pseudo_mesh = false |
| int | nspin = 1 |
| LDA ; LSDA ; non-linear spin. | |
| int | pw_diag_nmax = 50 |
| double | pw_diag_thr = 0.01 |
| used in cg method | |
| bool | diago_smooth_ethr = false |
| smooth ethr for iter methods | |
| int | pw_diag_ndim = 4 |
| dimension of workspace for Davidson diagonalization | |
| int | diago_cg_prec = 1 |
| mohan add 2012-03-31 | |
| int | diag_subspace = 0 |
| bool | use_k_continuity = false |
| whether to use k-point continuity for initializing wave functions | |
| std::string | smearing_method = "gauss" |
| double | smearing_sigma = 0.015 |
| std::string | mixing_mode = "broyden" |
| "plain","broyden",... | |
| double | mixing_beta = -1.0 |
| 0 : no_mixing | |
| int | mixing_ndim = 8 |
| used in Broyden method | |
| double | mixing_restart = 0.0 |
| double | mixing_gg0 = 1.0 |
| used in kerker method | |
| double | mixing_beta_mag = -10.0 |
| double | mixing_gg0_mag = 0.0 |
| double | mixing_gg0_min = 0.1 |
| double | mixing_angle = -10.0 |
| bool | mixing_tau = false |
| whether to mix tau in mgga | |
| bool | mixing_dftu = false |
| whether to mix locale in DFT+U | |
| bool | mixing_dmr = false |
| whether to mix real space density matrix | |
| bool | gamma_only = false |
| for plane wave. | |
| int | scf_nmax = 100 |
| number of max elec iter | |
| double | scf_thr = -1.0 |
| \sum |rhog_out - rhog_in |^2 | |
| double | scf_ene_thr = -1.0 |
| energy threshold for scf convergence, in eV | |
| int | scf_thr_type = -1 |
| type of the criterion of scf_thr, 1: reci drho, 2: real drho | |
| bool | scf_os_stop = false |
| whether to stop scf when oscillation is detected | |
| double | scf_os_thr = -0.01 |
| drho threshold for oscillation | |
| int | scf_os_ndim = 0 |
| number of old iterations used for oscillation detection | |
| int | sc_os_ndim = 5 |
| number of old iterations used for oscillation detection in Spin-Constrained DFT | |
| bool | lspinorb = false |
| consider the spin-orbit interaction | |
| bool | noncolin = false |
| using non-collinear-spin | |
| double | soc_lambda = 1.0 |
| The fraction of SOC based on scalar relativity (SR) of the pseudopotential. | |
| int | dfthalf_type = 0 |
| DFT-1/2 type, 0:off, 1: shell DFT-1/2. | |
| int | nb2d = 0 |
| matrix 2d division. | |
| int | lmaxmax = 2 |
| maximum of l channels used | |
| double | lcao_ecut = 0.0 |
| ecut of two center integral | |
| double | lcao_dk = 0.01 |
| delta k used in two center integral | |
| double | lcao_dr = 0.01 |
| dr used in two center integral | |
| double | lcao_rmax = 30.0 |
| rmax(a.u.) to make table. | |
| double | search_radius = -1.0 |
| 11.1 | |
| int | bx = 0 |
| int | by = 0 |
| int | bz = 0 |
| big mesh ball. 0: auto set bx/by/bz | |
| int | elpa_num_thread = -1 |
| Number of threads need to use in elpa. | |
| int | nstream = 4 |
| Number of streams in CUDA as per input data. | |
| std::string | bessel_nao_ecut = "default" |
| energy cutoff for spherical bessel functions(Ry) | |
| double | bessel_nao_tolerence = 1e-12 |
| tolerance for spherical bessel root | |
| std::vector< double > | bessel_nao_rcuts = {} |
| No specific values provided for bessel_nao_rcuts. | |
| bool | bessel_nao_smooth = true |
| spherical bessel smooth or not | |
| double | bessel_nao_sigma = 0.1 |
| spherical bessel smearing_sigma | |
| std::vector< std::string > | relax_method = {"cg","1"} |
| methods to move_ion: sd, bfgs, cg... | |
| bool | relax_new = true |
| bool | relax = false |
| allow relaxation along the specific direction | |
| double | relax_scale_force = 0.5 |
| int | relax_nmax = -1 |
| number of max ionic iter | |
| double | relax_cg_thr = 0.5 |
| threshold when cg to bfgs, pengfei add 2011-08-15 | |
| double | force_thr = -1 |
| threshold of force in unit (Ry/Bohr) | |
| double | force_thr_ev = -1 |
| threshold of force in unit (eV/Angstrom) | |
| double | force_zero_out = 0 |
| invalid force threshold, mohan add 2011-04-17 | |
| double | stress_thr = 0.5 |
| Pengfei Li 2017-11-01 ///<LiuXh update 20180515. | |
| double | press1 = 0 |
| double | press2 = 0 |
| double | press3 = 0 |
| double | relax_bfgs_w1 = 0.01 |
| wolfe condition 1 | |
| double | relax_bfgs_w2 = 0.5 |
| wolfe condition 2 | |
| double | relax_bfgs_rmax = 0.2 |
| trust radius max | |
| double | relax_bfgs_rmin = 1e-05 |
| trust radius min | |
| double | relax_bfgs_init = 0.5 |
| initial move | |
| std::string | fixed_axes = "None" |
| which axes are fixed | |
| bool | fixed_ibrav = false |
| bool | fixed_atoms = false |
| whether to fix atoms during vc-relax | |
| MD_para | mdp |
| double | ref_cell_factor = 1 |
| bool | cal_syns = false |
| calculate asynchronous S matrix to output | |
| double | dmax = 0.01 |
| maximum displacement of all atoms in one step (bohr) | |
| std::string | of_kinetic = "wt" |
| Kinetic energy functional, such as TF, VW, WT, TF+. | |
| std::string | of_method = "tn" |
| optimization method, include cg1, cg2, tn (default), bfgs | |
| std::string | of_conv = "energy" |
| double | of_tole = 1e-06 |
| double | of_tolp = 1e-05 |
| double | of_tf_weight = 1.0 |
| weight of TF KEDF | |
| double | of_vw_weight = 1.0 |
| weight of vW KEDF | |
| double | of_wt_alpha = 5. / 6. |
| parameter alpha of WT KEDF | |
| double | of_wt_beta = 5. / 6. |
| parameter beta of WT KEDF | |
| double | of_wt_rho0 = 0.0 |
| set the average density of system, in Bohr^-3 | |
| bool | of_hold_rho0 = false |
| double | of_lkt_a = 1.3 |
| parameter a of LKT KEDF | |
| bool | of_full_pw = true |
| int | of_full_pw_dim = 0 |
| bool | of_read_kernel = false |
| std::string | of_kernel_file = "WTkernel.txt" |
| The name of WT kernel file. | |
| double | of_xwm_kappa = 0.0 |
| The parameter kappa of XWM KEDF. | |
| double | of_xwm_rho_ref = 0.0 |
| The reference density of XWM KEDF. | |
| bool | of_ml_gene_data = false |
| Generate training data or not. | |
| std::string | of_ml_device = "cpu" |
| Run NN on GPU or CPU. | |
| int | of_ml_feg = 0 |
| The Free Electron Gas limit: 0: no, 3: yes. | |
| int | of_ml_nkernel = 1 |
| Number of kernels. | |
| std::vector< int > | of_ml_kernel = {1} |
| Type of kernel, 1 for wt, 2 for yukawa, and 3 for TKK. | |
| std::vector< double > | of_ml_kernel_scaling = {1.0} |
| Scaling parameter of kernel, w(r-r') = lambda^3 * w(lambda (r-r')), lambda = 1/scaling. | |
| std::vector< double > | of_ml_yukawa_alpha = {1.0} |
| Parameter alpha of yukawa kernel. | |
| std::vector< std::string > | of_ml_kernel_file = {"none"} |
| The file of TKK. | |
| bool | of_ml_gamma = false |
| Descriptor: gamma = (rho / rho0)^(1/3) | |
| bool | of_ml_p = false |
| Descriptor: p = |nabla rho|^2 / [2 (3 pi^2)^(1/3) rho^(4/3)]^2. | |
| bool | of_ml_q = false |
| Descriptor: q = nabla^2 rho / [4 (3 pi^2)^(2/3) rho^(5/3)]. | |
| bool | of_ml_tanhp = false |
| Descriptor: tanhp = tanh(chi_p * p) | |
| bool | of_ml_tanhq = false |
| Descriptor: tanhq = tanh(chi_q * q) | |
| double | of_ml_chi_p = 1.0 |
| Hyperparameter: tanhp = tanh(chi_p * p) | |
| double | of_ml_chi_q = 1.0 |
| Hyperparameter: tanhq = tanh(chi_q * q) | |
| std::vector< int > | of_ml_gammanl = {0} |
| Descriptor: gammanl = int{gamma(r') * w(r-r') dr'}. | |
| std::vector< int > | of_ml_pnl = {0} |
| Descriptor: pnl = int{p(r') * w(r-r') dr'}. | |
| std::vector< int > | of_ml_qnl = {0} |
| Descriptor: qnl = int{q(r') * w(r-r') dr'}. | |
| std::vector< int > | of_ml_xi = {0} |
| Descriptor: xi = int{rho(r')^(1/3) * w(r-r') dr'} / rho^(1/3) | |
| std::vector< int > | of_ml_tanhxi = {0} |
| Descriptor: tanhxi = tanh(chi_xi * xi) | |
| std::vector< int > | of_ml_tanhxi_nl = {0} |
| Descriptor: tanhxi_nl = int{tanhxi(r') * w(r-r') dr'}. | |
| std::vector< int > | of_ml_tanh_pnl = {0} |
| Descriptor: tanh_pnl = tanh(chi_pnl * pnl) | |
| std::vector< int > | of_ml_tanh_qnl = {0} |
| Descriptor: tanh_qnl = tanh(chi_qnl * qnl) | |
| std::vector< int > | of_ml_tanhp_nl = {0} |
| Descriptor: tanhp_nl = int{tanhp(r') * w(r-r') dr'}. | |
| std::vector< int > | of_ml_tanhq_nl = {0} |
| Descriptor: tanhq_nl = int{tanhq(r') * w(r-r') dr'}. | |
| std::vector< double > | of_ml_chi_xi = {1.0} |
| Hyperparameter: tanhpxi = tanh(chi_xi * xi) | |
| std::vector< double > | of_ml_chi_pnl = {1.0} |
| Hyperparameter: tanh_pnl = tanh(chi_pnl * pnl) | |
| std::vector< double > | of_ml_chi_qnl = {1.0} |
| Hyperparameter: tanh_qnl = tanh(chi_qnl * qnl) | |
| bool | of_ml_local_test = false |
| Test: read in the density, and output the F and Pauli potential. | |
| int | method_sto = 2 |
| int | npart_sto = 1 |
| for method_sto = 2, reduce memory | |
| int | nbands_sto = 256 |
| number of stochastic bands //qianrui 2021-2-5 | |
| int | nche_sto = 100 |
| double | emin_sto = 0 |
| Emin to normalize H. | |
| double | emax_sto = 0 |
| Emax to normalize H. | |
| int | seed_sto = 0 |
| random seed for sDFT | |
| double | initsto_ecut = 0.0 |
| maximum ecut to init stochastic bands | |
| int | initsto_freq = 0 |
| frequency to init stochastic orbitals when running md | |
| int | deepks_out_labels = 0 |
| int | deepks_out_freq_elec = 0 |
| std::string | deepks_out_base = "none" |
| bool | deepks_scf = false |
| default is "none", which means no base functional | |
| int | deepks_bandgap = 0 |
| for bandgap label. QO added 2021-12-15 | |
| std::vector< int > | deepks_band_range = {-1, 0} |
| the range of bands to calculate bandgap | |
| int | deepks_v_delta = 0 |
| for v_delta label. xuan added | |
| bool | deepks_equiv = false |
| whether to use equivariant version of DeePKS | |
| bool | deepks_out_unittest = false |
| std::string | deepks_model = "None" |
| needed when deepks_scf=1 | |
| int | bessel_descriptor_lmax = 2 |
| lmax used in descriptor | |
| std::string | bessel_descriptor_ecut = "default" |
| energy cutoff for spherical bessel functions(Ry) | |
| double | bessel_descriptor_tolerence = 1e-12 |
| tolerance for spherical bessel root | |
| double | bessel_descriptor_rcut = 6.0 |
| radial cutoff for spherical bessel functions(a.u.) | |
| bool | bessel_descriptor_smooth = true |
| spherical bessel smooth or not | |
| double | bessel_descriptor_sigma = 0.1 |
| spherical bessel smearing_sigma | |
| double | td_dt = -1.0 |
| time step for propagation | |
| int | estep_per_md = 1 |
| number of electronic steps per MD step | |
| bool | td_vext = false |
| add extern potential or not | |
| std::vector< int > | td_vext_dire = {1} |
| vector of vext direction | |
| bool | init_vecpot_file = false |
| initialize the vector potential, though file or integral | |
| double | td_print_eij = -1.0 |
| threshold to output Eij elements | |
| int | td_edm = 0 |
| 0: new edm method 1: old edm method | |
| int | propagator = 0 |
| method of propagator | |
| int | td_stype = 0 |
| type of space domain 0 : length gauge 1: velocity gauge | |
| std::string | td_ttype = "0" |
| int | td_tstart = 1 |
| int | td_tend = 1000 |
| double | td_lcut1 = 0.05 |
| double | td_lcut2 = 0.95 |
| std::string | td_gauss_freq = "22.13" |
| time(fs)^-1 | |
| std::string | td_gauss_phase = "0.0" |
| std::string | td_gauss_sigma = "30.0" |
| time(fs) | |
| std::string | td_gauss_t0 = "100.0" |
| std::string | td_gauss_amp = "0.25" |
| V/A. | |
| std::string | td_trape_freq = "1.60" |
| time(fs)^-1 | |
| std::string | td_trape_phase = "0.0" |
| std::string | td_trape_t1 = "1875.0" |
| std::string | td_trape_t2 = "5625.0" |
| std::string | td_trape_t3 = "7500.0" |
| std::string | td_trape_amp = "2.74" |
| std::string | td_trigo_freq1 = "1.164656" |
| std::string | td_trigo_freq2 = "0.029116" |
| std::string | td_trigo_phase1 = "0.0" |
| std::string | td_trigo_phase2 = "0.0" |
| std::string | td_trigo_amp = "2.74" |
| std::string | td_heavi_t0 = "100.0" |
| std::string | td_heavi_amp = "1.0" |
| bool | ocp = false |
| std::vector< double > | ocp_kb = {} |
| OCP kb values. | |
| int | lr_nstates = 1 |
| the number of 2-particle states to be solved | |
| std::vector< std::string > | lr_init_xc_kernel = {} |
| The method to initalize the xc kernel. | |
| int | nocc = -1 |
| the number of occupied orbitals to form the 2-particle basis | |
| int | nvirt = 1 |
| the number of virtual orbitals to form the 2-particle basis (nocc + nvirt <= nbands) | |
| std::string | xc_kernel = "LDA" |
| exchange correlation (XC) kernel for LR-TDDFT | |
| std::string | lr_solver = "dav" |
| the eigensolver for LR-TDDFT | |
| double | lr_thr = 1e-2 |
| convergence threshold of the LR-TDDFT eigensolver | |
| bool | out_wfc_lr = false |
| whether to output the eigenvectors (excitation amplitudes) in the particle-hole basis | |
| bool | lr_unrestricted = false |
| whether to use the unrestricted construction for LR-TDDFT | |
| std::vector< double > | abs_wavelen_range = {} |
| the range of wavelength(nm) to output the absorption spectrum | |
| double | abs_broadening = 0.01 |
| the broadening (eta) for LR-TDDFT absorption spectrum | |
| std::string | abs_gauge = "length" |
| whether to use length or velocity gauge to calculate the absorption spectrum in LR-TDDFT | |
| std::string | ri_hartree_benchmark = "none" |
| std::vector< int > | aims_nbasis = {} |
| the number of basis functions for each atom type used in FHI-aims (for benchmark) | |
| bool | out_stru = false |
| outut stru file each ion step | |
| int | out_freq_elec = 0 |
| print information every few electronic steps | |
| int | out_freq_ion = 0 |
| print information every few ionic steps | |
| std::vector< int > | out_chg = {0, 3} |
| output charge density. 0: no; 1: yes | |
| std::vector< int > | out_xc_r = {-1, 3} |
| output xc(r). -1: no; >=0: output the order of xc(r) | |
| int | out_pot = 0 |
| yes or no | |
| int | out_wfc_pw = 0 |
| 0: no; 1: txt; 2: dat | |
| std::vector< int > | out_band = {0, 8} |
| band calculation pengfei 2014-10-13 | |
| int | out_dos = 0 |
| dos calculation. mohan add 20090909 | |
| std::vector< int > | out_ldos = {0, 3} |
| ldos calculation | |
| bool | out_mul = false |
| qifeng add 2019-9-10 | |
| bool | out_proj_band = false |
| projected band structure calculation jiyy add 2022-05-11 | |
| std::string | out_level = "ie" |
| control the output information. | |
| std::vector< int > | out_dmr = {0, 8} |
| output density matrix in real space DM(R) | |
| std::vector< int > | out_dmk = {0, 8} |
| output density matrix in reciprocal space DM(k) | |
| std::vector< int > | out_mat_hs = {0, 8} |
| output H matrix and S matrix in local basis. | |
| std::vector< int > | out_mat_tk = {0, 8} |
| output T(k) matrix in local basis. | |
| std::vector< int > | out_mat_l = {0, 8} |
| output L matrix in local basis. | |
| bool | out_mat_hs2 = false |
| bool | out_mat_dh = false |
| bool | out_mat_ds = false |
| bool | out_mat_xc = false |
| bool | out_mat_xc2 = false |
| output exchange-correlation matrix Vxc(R) in NAO representation. | |
| bool | out_eband_terms = false |
| output the band energy terms separately | |
| bool | out_app_flag = true |
| int | out_ndigits = 8 |
| Assuming 8 digits precision is needed for matrices output. | |
| bool | out_mat_t = false |
| bool | out_element_info = false |
| output information of all elements | |
| bool | out_mat_r = false |
| jingan add 2019-8-14, output r(R) matrix. | |
| int | out_wfc_lcao = 0 |
| output the wave functions in local basis. | |
| bool | out_dipole = false |
| output the dipole or not | |
| bool | out_efield = false |
| output the efield or not | |
| bool | out_current = false |
| output the current or not | |
| bool | out_current_k = false |
| output tddft current for all k points | |
| bool | out_vecpot = false |
| output the vector potential or not | |
| bool | restart_save = false |
| restart //Peize Lin add 2020-04-04 | |
| bool | rpa = false |
| rpa calculation | |
| std::vector< int > | out_pchg = {} |
| specify the bands to be calculated for partial charge | |
| std::vector< int > | out_wfc_norm = {} |
| specify the bands to be calculated for norm of wfc | |
| std::vector< int > | out_wfc_re_im = {} |
| specify the bands to be calculated for real and imaginary parts of wfc | |
| bool | if_separate_k = false |
| whether to write partial charge for all k-points to individual files or merge them | |
| std::vector< int > | out_elf = {0, 3} |
| output the electron localization function (ELF). 0: no; 1: yes | |
| std::vector< int > | cal_symm_repr = {0, 3} |
| output the symmetry representation matrix | |
| int | out_spillage = 0 |
| output the spillage of the wave function | |
| std::string | spillage_outdir = "./" |
| output directory for spillage | |
| double | dos_emin_ev = -15.0 |
| double | dos_emax_ev = 15.0 |
| double | dos_edelta_ev = 0.01 |
| double | dos_scale = 0.01 |
| double | dos_sigma = 0.07 |
| pengfei 2014-10-13 | |
| int | dos_nche = 100 |
| orders of Chebyshev expansions for dos | |
| std::vector< double > | stm_bias = {1.0, 0.1, 1} |
| bias voltage for STM (start value, step, number) | |
| std::vector< double > | ldos_line |
| start and end point of the line (direct coordinates) and number of points | |
| bool | cal_cond = false |
| calculate electronic conductivities | |
| double | cond_che_thr = 1e-8 |
| double | cond_dw = 0.1 |
| d\omega for conductivities | |
| double | cond_wcut = 10 |
| cutoff \omega for conductivities | |
| double | cond_dt = 0.02 |
| dt to integrate conductivities | |
| int | cond_dtbatch = 0 |
| exp(iH*dt*cond_dtbatch) is expanded with Chebyshev expansion. | |
| int | cond_smear = 1 |
| smearing method for conductivities 1: Gaussian 2: Lorentzian | |
| double | cond_fwhm = 0.4 |
| FWHM for conductivities. | |
| bool | cond_nonlocal = true |
| if calculate nonlocal effects | |
| bool | berry_phase = false |
| berry phase calculation: calculate berry phase or not | |
| int | gdir = 3 |
| bool | towannier90 = false |
| std::string | nnkpfile = "seedname.nnkp" |
| std::string | wannier_spin = "up" |
| int | wannier_method = 1 |
| different implementation methods under Lcao basis set | |
| bool | out_wannier_mmn = true |
| add by renxi for wannier90: output .mmn file or not | |
| bool | out_wannier_amn = true |
| output .amn file or not | |
| bool | out_wannier_unk = false |
| output UNK. file or not | |
| bool | out_wannier_eig = true |
| output .eig file or not | |
| bool | out_wannier_wvfn_formatted = true |
| output UNK. file in text format or in binary format | |
| bool | efield_flag = false |
| add electric field | |
| bool | dip_cor_flag = false |
| dipole correction | |
| int | efield_dir = 2 |
| the direction of the electric field or dipole correction | |
| double | efield_pos_max = -1 |
| double | efield_pos_dec = -1 |
| zone in the unit cell where the saw-like potential decreases | |
| double | efield_amp = 0 |
| amplitude of the electric field | |
| bool | gate_flag = false |
| compensating charge or not | |
| double | zgate = 0.5 |
| position of charged plate | |
| bool | block = false |
| add a block potential or not | |
| double | block_down = 0.45 |
| low bound of the block | |
| double | block_up = 0.55 |
| high bound of the block | |
| double | block_height = 0.1 |
| height of the block | |
| bool | imp_sol = false |
| double | eb_k = 80 |
| the relative permittivity of the bulk solvent | |
| double | tau = 1.0798e-05 |
| the effective surface tension parameter | |
| double | sigma_k = 0.6 |
| the width of the diffuse cavity | |
| double | nc_k = 0.00037 |
| the cut-off charge density | |
| std::string | vdw_method = "none" |
| the method of calculating vdw (none; d2; d3_0; d3_bj) | |
| std::string | vdw_s6 = "default" |
| scale parameter of d2/d3_0/d3_bj | |
| std::string | vdw_s8 = "default" |
| scale parameter of d3_0/d3_bj | |
| std::string | vdw_a1 = "default" |
| damping parameter of d3_0/d3_bj | |
| std::string | vdw_a2 = "default" |
| damping parameter of d3_bj | |
| double | vdw_d = 20.0 |
| damping parameter of d2 | |
| bool | vdw_abc = false |
| third-order term? | |
| std::string | vdw_C6_file = "default" |
| filename of C6 | |
| std::string | vdw_C6_unit = "Jnm6/mol" |
| unit of C6, Jnm6/mol or eVA6 | |
| std::string | vdw_R0_file = "default" |
| filename of R0 | |
| std::string | vdw_R0_unit = "A" |
| unit of R0, A or Bohr | |
| std::string | vdw_cutoff_type = "radius" |
| std::string | vdw_cutoff_radius = "default" |
| radius cutoff for periodic structure | |
| std::string | vdw_radius_unit = "Bohr" |
| unit of radius cutoff for periodic structure | |
| double | vdw_cn_thr = 40.0 |
| radius cutoff for cn | |
| std::string | vdw_cn_thr_unit = "Bohr" |
| unit of cn_thr, Bohr or Angstrom | |
| ModuleBase::Vector3< int > | vdw_cutoff_period = {3, 3, 3} |
| periods of periodic structure | |
| std::vector< std::string > | exx_fock_alpha = {"default"} |
| fraction of Fock exchange 1/r in hybrid functionals | |
| std::vector< std::string > | exx_fock_lambda = {"default"} |
| std::vector< std::string > | exx_erfc_alpha = {"default"} |
| fraction of exchange erfc(wr)/r in hybrid functionals | |
| std::vector< std::string > | exx_erfc_omega = {"default"} |
| range-separation parameter in HSE functional | |
| bool | exx_separate_loop = true |
| std::string | exx_singularity_correction = "default" |
| set the scheme of Coulomb singularity correction | |
| int | exx_hybrid_step = 100 |
| double | exx_mixing_beta = 1.0 |
| mixing_beta for outer-loop when exx_separate_loop=1 | |
| std::string | exx_real_number = "default" |
| exx calculated in real or complex | |
| double | exx_pca_threshold = 0.0001 |
| threshold to screen on-site ABFs in exx | |
| double | exx_c_threshold = 0.0001 |
| threshold to screen C matrix in exx | |
| double | exx_v_threshold = 0.1 |
| threshold to screen C matrix in exx | |
| double | exx_dm_threshold = 0.0001 |
| threshold to screen density matrix in exx | |
| double | exx_c_grad_threshold = 0.0001 |
| threshold to screen nabla C matrix in exx | |
| double | exx_v_grad_threshold = 0.1 |
| threshold to screen nabla V matrix in exx | |
| double | exx_c_grad_r_threshold = 0.0001 |
| threshold to screen nabla C * R matrix in exx | |
| double | exx_v_grad_r_threshold = 0.1 |
| threshold to screen nabla V * R matrix in exx | |
| std::string | exx_ccp_rmesh_times = "default" |
| int | exx_opt_orb_lmax = 0 |
| the maximum l of the spherical Bessel functions for opt ABFs | |
| double | exx_opt_orb_ecut = 0.0 |
| the cut-off of plane wave expansion for opt ABFs | |
| double | exx_opt_orb_tolerence = 1E-12 |
| bool | exx_symmetry_realspace = true |
| whether to reduce the real-space sector in when using symmetry=1 in EXX calculation | |
| double | rpa_ccp_rmesh_times = 10.0 |
| bool | out_ri_cv = false |
| Whether to output the coefficient tensor C and ABFs-representation Coulomb matrix V. | |
| int | dft_plus_u = 0 |
| 0: standard DFT calculation (default) | |
| bool | dft_plus_dmft = false |
| true:DFT+DMFT; false: standard DFT calcullation(default) | |
| bool | yukawa_potential = false |
| default: false | |
| double | yukawa_lambda = -1.0 |
| default: -1.0, which means we calculate lambda | |
| double | uramping_eV = -1.0 |
| U-Ramping method (eV) | |
| int | omc = 0 |
| the mode of occupation matrix control | |
| double | onsite_radius = 0.0 |
| radius of the sphere for onsite projection (Bohr) | |
| std::vector< double > | hubbard_u_eV = {} |
| Hubbard Coulomb interaction parameter U(ev) | |
| std::vector< int > | orbital_corr = {} |
| bool | sc_mag_switch = false |
| bool | decay_grad_switch = false |
| double | sc_thr = 1e-06 |
| threshold for spin-constrained DFT in uB | |
| int | nsc = 100 |
| maximum number of inner lambda loop | |
| int | nsc_min = 2 |
| minimum number of inner lambda loop | |
| int | sc_scf_nmin = 2 |
| minimum number of outer scf loop before initial lambda loop | |
| double | alpha_trial = 0.01 |
| initial trial step size for lambda in eV/uB^2 | |
| double | sccut = 3.0 |
| restriction of step size in eV/uB | |
| double | sc_scf_thr = 1e-3 |
| minimum number of outer scf loop before initial lambda loop | |
| double | sc_drop_thr = 1e-3 |
| threshold for lambda-loop threshold cutoff in spin-constrained DFT | |
| bool | qo_switch = false |
| 0: no QO analysis; 1: QO analysis | |
| std::string | qo_basis = "szv" |
| double | qo_thr = 1e-06 |
| std::vector< std::string > | qo_strategy = {} |
| No specific values provided for qo_strategy. | |
| std::vector< double > | qo_screening_coeff = {} |
| No specific values provided for qo_screening_coeff. | |
| int | pexsi_npole = 40 |
| bool | pexsi_inertia = true |
| int | pexsi_nmax = 80 |
| bool | pexsi_comm = true |
| bool | pexsi_storage = true |
| int | pexsi_ordering = 0 |
| int | pexsi_row_ordering = 1 |
| int | pexsi_nproc = 1 |
| bool | pexsi_symm = true |
| bool | pexsi_trans = false |
| int | pexsi_method = 1 |
| int | pexsi_nproc_pole = 1 |
| double | pexsi_temp = 0.015 |
| double | pexsi_gap = 0 |
| double | pexsi_delta_e = 20.0 |
| double | pexsi_mu_lower = -10 |
| double | pexsi_mu_upper = 10 |
| double | pexsi_mu = 0.0 |
| double | pexsi_mu_thr = 0.05 |
| double | pexsi_mu_expand = 0.3 |
| double | pexsi_mu_guard = 0.2 |
| double | pexsi_elec_thr = 0.001 |
| double | pexsi_zero_thr = 1e-10 |
| bool | out_alllog = false |
| output all logs. | |
| int | nurse = 0 |
| used for debug. | |
| bool | t_in_h = true |
| calculate the T or not. | |
| bool | vl_in_h = true |
| calculate the vloc or not. | |
| bool | vnl_in_h = true |
| calculate the vnl or not. | |
| bool | vh_in_h = true |
| calculate the hartree potential or not | |
| bool | vion_in_h = true |
| bool | test_force = false |
| test the force. | |
| bool | test_stress = false |
| test the stress. | |
| bool | test_skip_ewald = false |
| variables for test only | |
| int | test_atom_input = false |
| variables for test_atom_input only | |
| int | test_wf = 0 |
| variables for test_wf only | |
| int | test_grid = false |
| variables for test_grid only | |
| int | test_charge = false |
| variables for test_vloc only | |
| int | test_energy = false |
| variables for test_energy only | |
| int | test_gridt = false |
| variables for test_gridt only | |
| int | test_pseudo_cell = false |
| variables for test_pseudo_cell only | |
| int | test_pp = 0 |
| variables for test_pp only | |
| int | test_relax_method = false |
| variables for test_relax_method only | |
| int | test_deconstructor = false |
| variables for test_deconstructor only | |
| bool | rdmft = false |
| double | rdmft_power_alpha = 0.656 |
| bool | exxace = true |
| bool | exx_gamma_extrapolation = true |
| std::string | exx_thr_type = "density" |
| double | exx_ene_thr = 1e-5 |
| double | ecutexx = 0.0 |
| std::vector< double > | xc_exch_ext |
| std::vector< double > | xc_corr_ext |
| bool | of_cd = false |
| add CD potential or not https://doi.org/10.1103/PhysRevB.98.144302 | |
| double | of_mCD_alpha = 1.0 |
| double Input_para::abs_broadening = 0.01 |
the broadening (eta) for LR-TDDFT absorption spectrum
| std::string Input_para::abs_gauge = "length" |
whether to use length or velocity gauge to calculate the absorption spectrum in LR-TDDFT
| std::vector<double> Input_para::abs_wavelen_range = {} |
the range of wavelength(nm) to output the absorption spectrum
| std::vector<int> Input_para::aims_nbasis = {} |
the number of basis functions for each atom type used in FHI-aims (for benchmark)
| double Input_para::alpha_trial = 0.01 |
initial trial step size for lambda in eV/uB^2
| std::string Input_para::basis_type = "pw" |
xiaohui add 2013-09-01, for structural adjustment
| bool Input_para::berry_phase = false |
berry phase calculation: calculate berry phase or not
| std::string Input_para::bessel_descriptor_ecut = "default" |
energy cutoff for spherical bessel functions(Ry)
| int Input_para::bessel_descriptor_lmax = 2 |
lmax used in descriptor
| double Input_para::bessel_descriptor_rcut = 6.0 |
radial cutoff for spherical bessel functions(a.u.)
| double Input_para::bessel_descriptor_sigma = 0.1 |
spherical bessel smearing_sigma
| bool Input_para::bessel_descriptor_smooth = true |
spherical bessel smooth or not
| double Input_para::bessel_descriptor_tolerence = 1e-12 |
tolerance for spherical bessel root
| std::string Input_para::bessel_nao_ecut = "default" |
energy cutoff for spherical bessel functions(Ry)
| std::vector<double> Input_para::bessel_nao_rcuts = {} |
No specific values provided for bessel_nao_rcuts.
| double Input_para::bessel_nao_sigma = 0.1 |
spherical bessel smearing_sigma
| bool Input_para::bessel_nao_smooth = true |
spherical bessel smooth or not
| double Input_para::bessel_nao_tolerence = 1e-12 |
tolerance for spherical bessel root
| bool Input_para::block = false |
add a block potential or not
| double Input_para::block_down = 0.45 |
low bound of the block
| double Input_para::block_height = 0.1 |
height of the block
| double Input_para::block_up = 0.55 |
high bound of the block
| int Input_para::bndpar = 1 |
parallel for stochastic/deterministic bands
| int Input_para::bx = 0 |
| int Input_para::by = 0 |
| int Input_para::bz = 0 |
big mesh ball. 0: auto set bx/by/bz
| bool Input_para::cal_cond = false |
calculate electronic conductivities
| bool Input_para::cal_force = false |
calculate the force
| bool Input_para::cal_stress = false |
calculate the stress
| std::vector<int> Input_para::cal_symm_repr = {0, 3} |
output the symmetry representation matrix
| bool Input_para::cal_syns = false |
calculate asynchronous S matrix to output
| std::string Input_para::calculation = "scf" |
"scf" : self consistent calculation. "nscf" : non-self consistent calculation. "relax" : cell relaxations
| double Input_para::cell_factor = 1.2 |
LiuXh add 20180619.
| std::string Input_para::chg_extrap = "default" |
xiaohui modify 2015-02-01
| double Input_para::cond_che_thr = 1e-8 |
control the error of Chebyshev expansions for conductivities
| double Input_para::cond_dt = 0.02 |
dt to integrate conductivities
| int Input_para::cond_dtbatch = 0 |
exp(iH*dt*cond_dtbatch) is expanded with Chebyshev expansion.
| double Input_para::cond_dw = 0.1 |
d\omega for conductivities
| double Input_para::cond_fwhm = 0.4 |
FWHM for conductivities.
| bool Input_para::cond_nonlocal = true |
if calculate nonlocal effects
| int Input_para::cond_smear = 1 |
smearing method for conductivities 1: Gaussian 2: Lorentzian
| double Input_para::cond_wcut = 10 |
cutoff \omega for conductivities
| bool Input_para::decay_grad_switch = false |
the switch to use the local approximation of gradient decay, 0: no local approximation; 1: apply the method
| std::vector<int> Input_para::deepks_band_range = {-1, 0} |
the range of bands to calculate bandgap
| int Input_para::deepks_bandgap = 0 |
for bandgap label. QO added 2021-12-15
| bool Input_para::deepks_equiv = false |
whether to use equivariant version of DeePKS
| std::string Input_para::deepks_model = "None" |
needed when deepks_scf=1
| std::string Input_para::deepks_out_base = "none" |
(need libnpy) base functional for output files, with dft_functional as target functional
| int Input_para::deepks_out_freq_elec = 0 |
(need libnpy) frequency of electronic iteration to output descriptors and labels, default is 0, which means no output until convergence
| int Input_para::deepks_out_labels = 0 |
(need libnpy) prints energy and force labels and descriptors for training, wenfei 2022-1-12
| bool Input_para::deepks_out_unittest = false |
if set to true, prints intermediate quantities that shall be used for making unit test
| bool Input_para::deepks_scf = false |
default is "none", which means no base functional
(need libnpy and libtorch) if set to true, a trained model would be needed to calculate V_delta and F_delta
| int Input_para::deepks_v_delta = 0 |
for v_delta label. xuan added
| std::string Input_para::device = "auto" |
| std::string Input_para::dft_functional = "default" |
input DFT functional.
| bool Input_para::dft_plus_dmft = false |
true:DFT+DMFT; false: standard DFT calcullation(default)
| int Input_para::dft_plus_u = 0 |
0: standard DFT calculation (default)
| int Input_para::dfthalf_type = 0 |
DFT-1/2 type, 0:off, 1: shell DFT-1/2.
| int Input_para::diag_subspace = 0 |
| int Input_para::diago_cg_prec = 1 |
mohan add 2012-03-31
| int Input_para::diago_proc = 0 |
the number of procs used to diag. mohan add 2012-01-13
| bool Input_para::diago_smooth_ethr = false |
smooth ethr for iter methods
| bool Input_para::dip_cor_flag = false |
dipole correction
| bool Input_para::dm_to_rho = false |
read density matrix from npz format and calculate charge density
| double Input_para::dmax = 0.01 |
maximum displacement of all atoms in one step (bohr)
| double Input_para::dos_edelta_ev = 0.01 |
| double Input_para::dos_emax_ev = 15.0 |
| double Input_para::dos_emin_ev = -15.0 |
| int Input_para::dos_nche = 100 |
orders of Chebyshev expansions for dos
| double Input_para::dos_scale = 0.01 |
| double Input_para::dos_sigma = 0.07 |
pengfei 2014-10-13
| double Input_para::eb_k = 80 |
the relative permittivity of the bulk solvent
| double Input_para::ecutexx = 0.0 |
| double Input_para::ecutrho = 0 |
energy cutoff for charge/potential
| double Input_para::ecutwfc = 0 |
energy cutoff for wavefunctions
| double Input_para::efield_amp = 0 |
amplitude of the electric field
| int Input_para::efield_dir = 2 |
the direction of the electric field or dipole correction
| bool Input_para::efield_flag = false |
add electric field
| double Input_para::efield_pos_dec = -1 |
zone in the unit cell where the saw-like potential decreases
| double Input_para::efield_pos_max = -1 |
position of the maximum of the saw-like potential along crystal axis efield_dir
| int Input_para::elpa_num_thread = -1 |
Number of threads need to use in elpa.
| double Input_para::emax_sto = 0 |
Emax to normalize H.
| double Input_para::emin_sto = 0 |
Emin to normalize H.
| double Input_para::erf_ecut = 0 |
the value of the constant energy cutoff
| double Input_para::erf_height = 0 |
the height of the energy step for reciprocal vectors
| double Input_para::erf_sigma = 0.1 |
the width of the energy step for reciprocal vectors
| std::string Input_para::esolver_type = "ksdft" |
the energy solver: ksdft, sdft, ofdft, tddft, lj, dp
| int Input_para::estep_per_md = 1 |
number of electronic steps per MD step
| double Input_para::exx_c_grad_r_threshold = 0.0001 |
threshold to screen nabla C * R matrix in exx
| double Input_para::exx_c_grad_threshold = 0.0001 |
threshold to screen nabla C matrix in exx
| double Input_para::exx_c_threshold = 0.0001 |
threshold to screen C matrix in exx
| std::string Input_para::exx_ccp_rmesh_times = "default" |
how many times larger the radial mesh required for calculating Columb potential is to that of atomic orbitals
| double Input_para::exx_dm_threshold = 0.0001 |
threshold to screen density matrix in exx
| double Input_para::exx_ene_thr = 1e-5 |
| std::vector<std::string> Input_para::exx_erfc_alpha = {"default"} |
fraction of exchange erfc(wr)/r in hybrid functionals
| std::vector<std::string> Input_para::exx_erfc_omega = {"default"} |
range-separation parameter in HSE functional
| std::vector<std::string> Input_para::exx_fock_alpha = {"default"} |
fraction of Fock exchange 1/r in hybrid functionals
| std::vector<std::string> Input_para::exx_fock_lambda = {"default"} |
used to compensate for divergence points at G=0 in the evaluation of Fock exchange using lcao_in_pw method
| bool Input_para::exx_gamma_extrapolation = true |
| int Input_para::exx_hybrid_step = 100 |
the maximal electronic iteration number in the evaluation of Fock exchange
| double Input_para::exx_mixing_beta = 1.0 |
mixing_beta for outer-loop when exx_separate_loop=1
| double Input_para::exx_opt_orb_ecut = 0.0 |
the cut-off of plane wave expansion for opt ABFs
| int Input_para::exx_opt_orb_lmax = 0 |
the maximum l of the spherical Bessel functions for opt ABFs
| double Input_para::exx_opt_orb_tolerence = 1E-12 |
the threshold when solving for the zeros of spherical Bessel functions for opt ABFs
| double Input_para::exx_pca_threshold = 0.0001 |
threshold to screen on-site ABFs in exx
| std::string Input_para::exx_real_number = "default" |
exx calculated in real or complex
| bool Input_para::exx_separate_loop = true |
if 1, a two-step method is employed, else it will start with a GGA-Loop, and then Hybrid-Loop
| std::string Input_para::exx_singularity_correction = "default" |
set the scheme of Coulomb singularity correction
| bool Input_para::exx_symmetry_realspace = true |
whether to reduce the real-space sector in when using symmetry=1 in EXX calculation
| std::string Input_para::exx_thr_type = "density" |
| double Input_para::exx_v_grad_r_threshold = 0.1 |
threshold to screen nabla V * R matrix in exx
| double Input_para::exx_v_grad_threshold = 0.1 |
threshold to screen nabla V matrix in exx
| double Input_para::exx_v_threshold = 0.1 |
threshold to screen C matrix in exx
| bool Input_para::exxace = true |
| int Input_para::fft_mode = 0 |
fftw mode 0: estimate, 1: measure, 2: patient, 3: exhaustive
| bool Input_para::fixed_atoms = false |
whether to fix atoms during vc-relax
| std::string Input_para::fixed_axes = "None" |
which axes are fixed
| bool Input_para::fixed_ibrav = false |
whether to keep type of lattice; must be used along with latname
| double Input_para::force_thr = -1 |
threshold of force in unit (Ry/Bohr)
| double Input_para::force_thr_ev = -1 |
threshold of force in unit (eV/Angstrom)
| double Input_para::force_zero_out = 0 |
invalid force threshold, mohan add 2011-04-17
| bool Input_para::gamma_only = false |
for plane wave.
| bool Input_para::gate_flag = false |
compensating charge or not
| int Input_para::gdir = 3 |
| std::vector<double> Input_para::hubbard_u_eV = {} |
Hubbard Coulomb interaction parameter U(ev)
| bool Input_para::if_separate_k = false |
whether to write partial charge for all k-points to individual files or merge them
| bool Input_para::imp_sol = false |
true: implicit solvation correction; false: vacuum calculation(default)
| std::string Input_para::init_chg = "atomic" |
"file","atomic"
| bool Input_para::init_vecpot_file = false |
initialize the vector potential, though file or integral
| bool Input_para::init_vel = false |
read velocity from STRU or not liuyu 2021-07-14
| std::string Input_para::init_wfc = "atomic" |
"file","atomic","random"
| double Input_para::initsto_ecut = 0.0 |
maximum ecut to init stochastic bands
| int Input_para::initsto_freq = 0 |
frequency to init stochastic orbitals when running md
| std::string Input_para::input_file = "INPUT" |
input file name
| int Input_para::kpar = 1 |
ecch pool is for one k point
| std::string Input_para::kpoint_file = "KPT" |
file contains k-points – xiaohui modify 2015-02-01
| std::string Input_para::ks_solver = "default" |
xiaohui add 2013-09-01
| std::vector<double> Input_para::kspacing = {0.0, 0.0, 0.0} |
kspacing for k-point generation
| std::string Input_para::latname = "none" |
lattice name
| double Input_para::lcao_dk = 0.01 |
delta k used in two center integral
| double Input_para::lcao_dr = 0.01 |
dr used in two center integral
| double Input_para::lcao_ecut = 0.0 |
ecut of two center integral
| double Input_para::lcao_rmax = 30.0 |
rmax(a.u.) to make table.
| std::vector<double> Input_para::ldos_line |
start and end point of the line (direct coordinates) and number of points
| int Input_para::lmaxmax = 2 |
maximum of l channels used
| std::vector<std::string> Input_para::lr_init_xc_kernel = {} |
The method to initalize the xc kernel.
| int Input_para::lr_nstates = 1 |
the number of 2-particle states to be solved
| std::string Input_para::lr_solver = "dav" |
the eigensolver for LR-TDDFT
| double Input_para::lr_thr = 1e-2 |
convergence threshold of the LR-TDDFT eigensolver
| bool Input_para::lr_unrestricted = false |
whether to use the unrestricted construction for LR-TDDFT
| bool Input_para::lspinorb = false |
consider the spin-orbit interaction
| MD_para Input_para::mdp |
| int Input_para::mem_saver = 0 |
1: save psi when nscf calculation.
| int Input_para::method_sto = 2 |
different methods for sdft, 1: slow, less memory 2: fast, more memory
| double Input_para::min_dist_coef = 0.2 |
allowed minimum distance between two atoms
| double Input_para::mixing_angle = -10.0 |
| double Input_para::mixing_beta = -1.0 |
0 : no_mixing
| double Input_para::mixing_beta_mag = -10.0 |
| bool Input_para::mixing_dftu = false |
whether to mix locale in DFT+U
| bool Input_para::mixing_dmr = false |
whether to mix real space density matrix
| double Input_para::mixing_gg0 = 1.0 |
used in kerker method
| double Input_para::mixing_gg0_mag = 0.0 |
| double Input_para::mixing_gg0_min = 0.1 |
| std::string Input_para::mixing_mode = "broyden" |
"plain","broyden",...
| int Input_para::mixing_ndim = 8 |
used in Broyden method
| double Input_para::mixing_restart = 0.0 |
mixing will restart once if drho is smaller than mixing_restart
| bool Input_para::mixing_tau = false |
whether to mix tau in mgga
| int Input_para::nb2d = 0 |
matrix 2d division.
| int Input_para::nbands = 0 |
number of bands
| int Input_para::nbands_sto = 256 |
number of stochastic bands //qianrui 2021-2-5
| int Input_para::nbspline = -1 |
the order of B-spline basis(>=0) if it is -1 (default)
| double Input_para::nc_k = 0.00037 |
the cut-off charge density
| int Input_para::nche_sto = 100 |
number of orders for Chebyshev expansion in stochastic DFT ///<qinarui 2021-2-5
| int Input_para::ndx = 0 |
| int Input_para::ndy = 0 |
| int Input_para::ndz = 0 |
three dimension of FFT smooth charge density
| double Input_para::nelec = 0.0 |
total number of electrons
| double Input_para::nelec_delta = 0.0 |
change in the number of total electrons
| std::string Input_para::nnkpfile = "seedname.nnkp" |
add by jingan for wannier90: the wannier90 code nnkp file name
| int Input_para::nocc = -1 |
the number of occupied orbitals to form the 2-particle basis
| bool Input_para::noncolin = false |
using non-collinear-spin
| int Input_para::npart_sto = 1 |
for method_sto = 2, reduce memory
| int Input_para::nsc = 100 |
maximum number of inner lambda loop
| int Input_para::nsc_min = 2 |
minimum number of inner lambda loop
| int Input_para::nspin = 1 |
LDA ; LSDA ; non-linear spin.
| int Input_para::nstream = 4 |
Number of streams in CUDA as per input data.
| int Input_para::ntype = 0 |
number of atom types
| double Input_para::nupdown = 0.0 |
| int Input_para::nurse = 0 |
used for debug.
| int Input_para::nvirt = 1 |
the number of virtual orbitals to form the 2-particle basis (nocc + nvirt <= nbands)
| int Input_para::nx = 0 |
| int Input_para::ny = 0 |
| int Input_para::nz = 0 |
three dimension of FFT wavefunc
| bool Input_para::ocp = false |
| std::vector<double> Input_para::ocp_kb = {} |
OCP kb values.
| bool Input_para::of_cd = false |
add CD potential or not https://doi.org/10.1103/PhysRevB.98.144302
| std::string Input_para::of_conv = "energy" |
select the convergence criterion, potential, energy (default), or both
| bool Input_para::of_full_pw = true |
If set to 1, ecut will be ignored while collecting planewaves, so that all planewaves will be used.
| int Input_para::of_full_pw_dim = 0 |
If of_full_pw = 1, the dimension of FFT will be restricted to be (0) either odd or even; (1) odd only; (2) even only.
| bool Input_para::of_hold_rho0 = false |
If set to 1, the rho0 will be fixed even if the volume of system has changed, it will be set to 1 automatically if of_wt_rho0 is not zero.
| std::string Input_para::of_kernel_file = "WTkernel.txt" |
The name of WT kernel file.
| std::string Input_para::of_kinetic = "wt" |
Kinetic energy functional, such as TF, VW, WT, TF+.
| double Input_para::of_lkt_a = 1.3 |
parameter a of LKT KEDF
| double Input_para::of_mCD_alpha = 1.0 |
| std::string Input_para::of_method = "tn" |
optimization method, include cg1, cg2, tn (default), bfgs
| double Input_para::of_ml_chi_p = 1.0 |
Hyperparameter: tanhp = tanh(chi_p * p)
| std::vector<double> Input_para::of_ml_chi_pnl = {1.0} |
Hyperparameter: tanh_pnl = tanh(chi_pnl * pnl)
| double Input_para::of_ml_chi_q = 1.0 |
Hyperparameter: tanhq = tanh(chi_q * q)
| std::vector<double> Input_para::of_ml_chi_qnl = {1.0} |
Hyperparameter: tanh_qnl = tanh(chi_qnl * qnl)
| std::vector<double> Input_para::of_ml_chi_xi = {1.0} |
Hyperparameter: tanhpxi = tanh(chi_xi * xi)
| std::string Input_para::of_ml_device = "cpu" |
Run NN on GPU or CPU.
| int Input_para::of_ml_feg = 0 |
The Free Electron Gas limit: 0: no, 3: yes.
| bool Input_para::of_ml_gamma = false |
Descriptor: gamma = (rho / rho0)^(1/3)
| std::vector<int> Input_para::of_ml_gammanl = {0} |
Descriptor: gammanl = int{gamma(r') * w(r-r') dr'}.
| bool Input_para::of_ml_gene_data = false |
Generate training data or not.
| std::vector<int> Input_para::of_ml_kernel = {1} |
Type of kernel, 1 for wt, 2 for yukawa, and 3 for TKK.
| std::vector<std::string> Input_para::of_ml_kernel_file = {"none"} |
The file of TKK.
| std::vector<double> Input_para::of_ml_kernel_scaling = {1.0} |
Scaling parameter of kernel, w(r-r') = lambda^3 * w(lambda (r-r')), lambda = 1/scaling.
| bool Input_para::of_ml_local_test = false |
Test: read in the density, and output the F and Pauli potential.
| int Input_para::of_ml_nkernel = 1 |
Number of kernels.
| bool Input_para::of_ml_p = false |
Descriptor: p = |nabla rho|^2 / [2 (3 pi^2)^(1/3) rho^(4/3)]^2.
| std::vector<int> Input_para::of_ml_pnl = {0} |
Descriptor: pnl = int{p(r') * w(r-r') dr'}.
| bool Input_para::of_ml_q = false |
Descriptor: q = nabla^2 rho / [4 (3 pi^2)^(2/3) rho^(5/3)].
| std::vector<int> Input_para::of_ml_qnl = {0} |
Descriptor: qnl = int{q(r') * w(r-r') dr'}.
| std::vector<int> Input_para::of_ml_tanh_pnl = {0} |
Descriptor: tanh_pnl = tanh(chi_pnl * pnl)
| std::vector<int> Input_para::of_ml_tanh_qnl = {0} |
Descriptor: tanh_qnl = tanh(chi_qnl * qnl)
| bool Input_para::of_ml_tanhp = false |
Descriptor: tanhp = tanh(chi_p * p)
| std::vector<int> Input_para::of_ml_tanhp_nl = {0} |
Descriptor: tanhp_nl = int{tanhp(r') * w(r-r') dr'}.
| bool Input_para::of_ml_tanhq = false |
Descriptor: tanhq = tanh(chi_q * q)
| std::vector<int> Input_para::of_ml_tanhq_nl = {0} |
Descriptor: tanhq_nl = int{tanhq(r') * w(r-r') dr'}.
| std::vector<int> Input_para::of_ml_tanhxi = {0} |
Descriptor: tanhxi = tanh(chi_xi * xi)
| std::vector<int> Input_para::of_ml_tanhxi_nl = {0} |
Descriptor: tanhxi_nl = int{tanhxi(r') * w(r-r') dr'}.
| std::vector<int> Input_para::of_ml_xi = {0} |
Descriptor: xi = int{rho(r')^(1/3) * w(r-r') dr'} / rho^(1/3)
| std::vector<double> Input_para::of_ml_yukawa_alpha = {1.0} |
Parameter alpha of yukawa kernel.
| bool Input_para::of_read_kernel = false |
If set to 1, the kernel of WT KEDF will be filled from file of_kernel_file, not from formula. Only usable for WT KEDF.
| double Input_para::of_tf_weight = 1.0 |
weight of TF KEDF
| double Input_para::of_tole = 1e-06 |
tolerance of the energy change (in Ry) for determining the convergence, default=2e-6 Ry
| double Input_para::of_tolp = 1e-05 |
tolerance of potential for determining the convergence, default=1e-5 in a.u.
| double Input_para::of_vw_weight = 1.0 |
weight of vW KEDF
| double Input_para::of_wt_alpha = 5. / 6. |
parameter alpha of WT KEDF
| double Input_para::of_wt_beta = 5. / 6. |
parameter beta of WT KEDF
| double Input_para::of_wt_rho0 = 0.0 |
set the average density of system, in Bohr^-3
| double Input_para::of_xwm_kappa = 0.0 |
The parameter kappa of XWM KEDF.
| double Input_para::of_xwm_rho_ref = 0.0 |
The reference density of XWM KEDF.
| int Input_para::omc = 0 |
the mode of occupation matrix control
| double Input_para::onsite_radius = 0.0 |
radius of the sphere for onsite projection (Bohr)
| std::vector<int> Input_para::orbital_corr = {} |
which correlated orbitals need corrected ; d:2 ,f:3, do not need correction:-1
| std::string Input_para::orbital_dir = "" |
directory of orbital file
| bool Input_para::out_alllog = false |
output all logs.
| bool Input_para::out_app_flag = true |
whether output r(R), H(R), S(R), T(R), and dH(R) matrices in an append manner during MD liuyu 2023-03-20
| std::vector<int> Input_para::out_band = {0, 8} |
band calculation pengfei 2014-10-13
| std::vector<int> Input_para::out_chg = {0, 3} |
output charge density. 0: no; 1: yes
| bool Input_para::out_current = false |
output the current or not
| bool Input_para::out_current_k = false |
output tddft current for all k points
| bool Input_para::out_dipole = false |
output the dipole or not
| std::vector<int> Input_para::out_dmk = {0, 8} |
output density matrix in reciprocal space DM(k)
| std::vector<int> Input_para::out_dmr = {0, 8} |
output density matrix in real space DM(R)
| int Input_para::out_dos = 0 |
dos calculation. mohan add 20090909
| bool Input_para::out_eband_terms = false |
output the band energy terms separately
| bool Input_para::out_efield = false |
output the efield or not
| bool Input_para::out_element_info = false |
output information of all elements
| std::vector<int> Input_para::out_elf = {0, 3} |
output the electron localization function (ELF). 0: no; 1: yes
| int Input_para::out_freq_elec = 0 |
print information every few electronic steps
| int Input_para::out_freq_ion = 0 |
print information every few ionic steps
| std::vector<int> Input_para::out_ldos = {0, 3} |
ldos calculation
| std::string Input_para::out_level = "ie" |
control the output information.
| bool Input_para::out_mat_dh = false |
| bool Input_para::out_mat_ds = false |
| std::vector<int> Input_para::out_mat_hs = {0, 8} |
output H matrix and S matrix in local basis.
| bool Input_para::out_mat_hs2 = false |
LiuXh add 2019-07-16, output H(R) matrix and S(R) matrix in local basis.
| std::vector<int> Input_para::out_mat_l = {0, 8} |
output L matrix in local basis.
| bool Input_para::out_mat_r = false |
jingan add 2019-8-14, output r(R) matrix.
| bool Input_para::out_mat_t = false |
| std::vector<int> Input_para::out_mat_tk = {0, 8} |
output T(k) matrix in local basis.
| bool Input_para::out_mat_xc = false |
output exchange-correlation matrix in KS-orbital representation.
| bool Input_para::out_mat_xc2 = false |
output exchange-correlation matrix Vxc(R) in NAO representation.
| bool Input_para::out_mul = false |
qifeng add 2019-9-10
| int Input_para::out_ndigits = 8 |
Assuming 8 digits precision is needed for matrices output.
| std::vector<int> Input_para::out_pchg = {} |
specify the bands to be calculated for partial charge
| int Input_para::out_pot = 0 |
yes or no
| bool Input_para::out_proj_band = false |
projected band structure calculation jiyy add 2022-05-11
| bool Input_para::out_ri_cv = false |
Whether to output the coefficient tensor C and ABFs-representation Coulomb matrix V.
| int Input_para::out_spillage = 0 |
output the spillage of the wave function
| bool Input_para::out_stru = false |
outut stru file each ion step
| bool Input_para::out_vecpot = false |
output the vector potential or not
| bool Input_para::out_wannier_amn = true |
output .amn file or not
| bool Input_para::out_wannier_eig = true |
output .eig file or not
| bool Input_para::out_wannier_mmn = true |
add by renxi for wannier90: output .mmn file or not
| bool Input_para::out_wannier_unk = false |
output UNK. file or not
| bool Input_para::out_wannier_wvfn_formatted = true |
output UNK. file in text format or in binary format
| int Input_para::out_wfc_lcao = 0 |
output the wave functions in local basis.
| bool Input_para::out_wfc_lr = false |
whether to output the eigenvectors (excitation amplitudes) in the particle-hole basis
| std::vector<int> Input_para::out_wfc_norm = {} |
specify the bands to be calculated for norm of wfc
| int Input_para::out_wfc_pw = 0 |
0: no; 1: txt; 2: dat
| std::vector<int> Input_para::out_wfc_re_im = {} |
specify the bands to be calculated for real and imaginary parts of wfc
| std::vector<int> Input_para::out_xc_r = {-1, 3} |
output xc(r). -1: no; >=0: output the order of xc(r)
| bool Input_para::pexsi_comm = true |
| double Input_para::pexsi_delta_e = 20.0 |
| double Input_para::pexsi_elec_thr = 0.001 |
| double Input_para::pexsi_gap = 0 |
| bool Input_para::pexsi_inertia = true |
| int Input_para::pexsi_method = 1 |
| double Input_para::pexsi_mu = 0.0 |
| double Input_para::pexsi_mu_expand = 0.3 |
| double Input_para::pexsi_mu_guard = 0.2 |
| double Input_para::pexsi_mu_lower = -10 |
| double Input_para::pexsi_mu_thr = 0.05 |
| double Input_para::pexsi_mu_upper = 10 |
| int Input_para::pexsi_nmax = 80 |
| int Input_para::pexsi_npole = 40 |
| int Input_para::pexsi_nproc = 1 |
| int Input_para::pexsi_nproc_pole = 1 |
| int Input_para::pexsi_ordering = 0 |
| int Input_para::pexsi_row_ordering = 1 |
| bool Input_para::pexsi_storage = true |
| bool Input_para::pexsi_symm = true |
| double Input_para::pexsi_temp = 0.015 |
| bool Input_para::pexsi_trans = false |
| double Input_para::pexsi_zero_thr = 1e-10 |
| std::string Input_para::precision = "double" |
| double Input_para::press1 = 0 |
| double Input_para::press2 = 0 |
| double Input_para::press3 = 0 |
| int Input_para::propagator = 0 |
method of propagator
| std::string Input_para::pseudo_dir = "" |
directory of pseudopotential
| bool Input_para::pseudo_mesh = false |
0: use msh to normalize radial wave functions; 1: use mesh, which is used in QE.
| double Input_para::pseudo_rcut = 15.0 |
cut-off radius for calculating msh
| int Input_para::pw_diag_ndim = 4 |
dimension of workspace for Davidson diagonalization
| int Input_para::pw_diag_nmax = 50 |
| double Input_para::pw_diag_thr = 0.01 |
used in cg method
| int Input_para::pw_seed = 0 |
random seed for initializing wave functions
| std::string Input_para::qo_basis = "szv" |
type of QO basis function: hydrogen: hydrogen-like basis, pswfc: read basis from pseudopotential
| std::vector<double> Input_para::qo_screening_coeff = {} |
No specific values provided for qo_screening_coeff.
| std::vector<std::string> Input_para::qo_strategy = {} |
No specific values provided for qo_strategy.
| bool Input_para::qo_switch = false |
| double Input_para::qo_thr = 1e-06 |
| bool Input_para::rdmft = false |
| double Input_para::rdmft_power_alpha = 0.656 |
| std::string Input_para::read_file_dir = "auto" |
directory of files for reading
| double Input_para::ref_cell_factor = 1 |
construct a reference cell bigger than the initial cell liuyu 2023-03-21
| bool Input_para::relax = false |
allow relaxation along the specific direction
| double Input_para::relax_bfgs_init = 0.5 |
initial move
| double Input_para::relax_bfgs_rmax = 0.2 |
trust radius max
| double Input_para::relax_bfgs_rmin = 1e-05 |
trust radius min
| double Input_para::relax_bfgs_w1 = 0.01 |
wolfe condition 1
| double Input_para::relax_bfgs_w2 = 0.5 |
wolfe condition 2
| double Input_para::relax_cg_thr = 0.5 |
threshold when cg to bfgs, pengfei add 2011-08-15
| std::vector<std::string> Input_para::relax_method = {"cg","1"} |
methods to move_ion: sd, bfgs, cg...
| bool Input_para::relax_new = true |
| int Input_para::relax_nmax = -1 |
number of max ionic iter
| double Input_para::relax_scale_force = 0.5 |
| bool Input_para::restart_load = false |
| bool Input_para::restart_save = false |
restart //Peize Lin add 2020-04-04
| std::string Input_para::ri_hartree_benchmark = "none" |
whether to use the RI approximation for the Hartree potential in LR-TDDFT for benchmark (with FHI-aims/ABACUS read-in style)
| bool Input_para::rpa = false |
rpa calculation
| double Input_para::rpa_ccp_rmesh_times = 10.0 |
how many times larger the radial mesh required for calculating Columb potential is to that of atomic orbitals
| double Input_para::sc_drop_thr = 1e-3 |
threshold for lambda-loop threshold cutoff in spin-constrained DFT
| bool Input_para::sc_mag_switch = false |
0: none spin-constrained DFT; 1: constrain atomic spin; the switch to open the DeltaSpin function, 0: no spin-constrained DFT; 1: constrain atomic magnetization
| int Input_para::sc_os_ndim = 5 |
number of old iterations used for oscillation detection in Spin-Constrained DFT
| int Input_para::sc_scf_nmin = 2 |
minimum number of outer scf loop before initial lambda loop
| double Input_para::sc_scf_thr = 1e-3 |
minimum number of outer scf loop before initial lambda loop
| double Input_para::sc_thr = 1e-06 |
threshold for spin-constrained DFT in uB
| double Input_para::sccut = 3.0 |
restriction of step size in eV/uB
| double Input_para::scf_ene_thr = -1.0 |
energy threshold for scf convergence, in eV
| int Input_para::scf_nmax = 100 |
number of max elec iter
| int Input_para::scf_os_ndim = 0 |
number of old iterations used for oscillation detection
| bool Input_para::scf_os_stop = false |
whether to stop scf when oscillation is detected
| double Input_para::scf_os_thr = -0.01 |
drho threshold for oscillation
| double Input_para::scf_thr = -1.0 |
\sum |rhog_out - rhog_in |^2
| int Input_para::scf_thr_type = -1 |
type of the criterion of scf_thr, 1: reci drho, 2: real drho
| double Input_para::search_radius = -1.0 |
11.1
| int Input_para::seed_sto = 0 |
random seed for sDFT
| double Input_para::sigma_k = 0.6 |
the width of the diffuse cavity
| std::string Input_para::smearing_method = "gauss" |
"gauss", "mp","methfessel-paxton" "mv","marzari-vanderbilt","cold" "fd","fermi-dirac"
| double Input_para::smearing_sigma = 0.015 |
| double Input_para::soc_lambda = 1.0 |
The fraction of SOC based on scalar relativity (SR) of the pseudopotential.
| std::string Input_para::spillage_outdir = "./" |
output directory for spillage
| std::vector<double> Input_para::stm_bias = {1.0, 0.1, 1} |
bias voltage for STM (start value, step, number)
| double Input_para::stress_thr = 0.5 |
Pengfei Li 2017-11-01 ///<LiuXh update 20180515.
| std::string Input_para::stru_file = "STRU" |
file contains atomic positions – xiaohui modify 2015-02-01
| std::string Input_para::suffix = "ABACUS" |
suffix of out put dir
| std::string Input_para::symmetry = "default" |
| bool Input_para::symmetry_autoclose = true |
whether to close symmetry automatically when error occurs in symmetry analysis
| double Input_para::symmetry_prec = 1.0e-6 |
LiuXh add 2021-08-12, accuracy for symmetry.
| bool Input_para::t_in_h = true |
calculate the T or not.
| double Input_para::tau = 1.0798e-05 |
the effective surface tension parameter
| double Input_para::td_dt = -1.0 |
time step for propagation
| int Input_para::td_edm = 0 |
0: new edm method 1: old edm method
| std::string Input_para::td_gauss_amp = "0.25" |
V/A.
trapezoid
| std::string Input_para::td_gauss_freq = "22.13" |
time(fs)^-1
| std::string Input_para::td_gauss_phase = "0.0" |
| std::string Input_para::td_gauss_sigma = "30.0" |
time(fs)
| std::string Input_para::td_gauss_t0 = "100.0" |
| std::string Input_para::td_heavi_amp = "1.0" |
| std::string Input_para::td_heavi_t0 = "100.0" |
| double Input_para::td_lcut1 = 0.05 |
| double Input_para::td_lcut2 = 0.95 |
time domain parameters Gauss
| double Input_para::td_print_eij = -1.0 |
threshold to output Eij elements
| int Input_para::td_stype = 0 |
type of space domain 0 : length gauge 1: velocity gauge
| int Input_para::td_tend = 1000 |
space domain parameters length gauge
| std::string Input_para::td_trape_amp = "2.74" |
| std::string Input_para::td_trape_freq = "1.60" |
time(fs)^-1
| std::string Input_para::td_trape_phase = "0.0" |
| std::string Input_para::td_trape_t1 = "1875.0" |
| std::string Input_para::td_trape_t2 = "5625.0" |
| std::string Input_para::td_trape_t3 = "7500.0" |
| std::string Input_para::td_trigo_amp = "2.74" |
| std::string Input_para::td_trigo_freq1 = "1.164656" |
| std::string Input_para::td_trigo_freq2 = "0.029116" |
| std::string Input_para::td_trigo_phase1 = "0.0" |
| std::string Input_para::td_trigo_phase2 = "0.0" |
| int Input_para::td_tstart = 1 |
| std::string Input_para::td_ttype = "0" |
type of time domain 0: Gaussian type function. 1: Trapezoid type function. 2: Trigonometric functions, sin^2. 3: Heaviside step function.
| bool Input_para::td_vext = false |
add extern potential or not
| std::vector<int> Input_para::td_vext_dire = {1} |
vector of vext direction
| int Input_para::test_atom_input = false |
variables for test_atom_input only
| int Input_para::test_charge = false |
variables for test_vloc only
| int Input_para::test_deconstructor = false |
variables for test_deconstructor only
| int Input_para::test_energy = false |
variables for test_energy only
| bool Input_para::test_force = false |
test the force.
| int Input_para::test_grid = false |
variables for test_grid only
| int Input_para::test_gridt = false |
variables for test_gridt only
| int Input_para::test_pp = 0 |
variables for test_pp only
| int Input_para::test_pseudo_cell = false |
variables for test_pseudo_cell only
| int Input_para::test_relax_method = false |
variables for test_relax_method only
| bool Input_para::test_skip_ewald = false |
variables for test only
| bool Input_para::test_stress = false |
test the stress.
| int Input_para::test_wf = 0 |
variables for test_wf only
| bool Input_para::timer_enable_nvtx = false |
| bool Input_para::towannier90 = false |
add by jingan for wannier90: use wannier90 code interface or not
| double Input_para::uramping_eV = -1.0 |
U-Ramping method (eV)
| bool Input_para::use_k_continuity = false |
whether to use k-point continuity for initializing wave functions
| std::string Input_para::vdw_a1 = "default" |
damping parameter of d3_0/d3_bj
| std::string Input_para::vdw_a2 = "default" |
damping parameter of d3_bj
| bool Input_para::vdw_abc = false |
third-order term?
| std::string Input_para::vdw_C6_file = "default" |
filename of C6
| std::string Input_para::vdw_C6_unit = "Jnm6/mol" |
unit of C6, Jnm6/mol or eVA6
| double Input_para::vdw_cn_thr = 40.0 |
radius cutoff for cn
| std::string Input_para::vdw_cn_thr_unit = "Bohr" |
unit of cn_thr, Bohr or Angstrom
| ModuleBase::Vector3<int> Input_para::vdw_cutoff_period = {3, 3, 3} |
periods of periodic structure
| std::string Input_para::vdw_cutoff_radius = "default" |
radius cutoff for periodic structure
| std::string Input_para::vdw_cutoff_type = "radius" |
expression model of periodic structure, radius or period
| double Input_para::vdw_d = 20.0 |
damping parameter of d2
| std::string Input_para::vdw_method = "none" |
the method of calculating vdw (none; d2; d3_0; d3_bj)
| std::string Input_para::vdw_R0_file = "default" |
filename of R0
| std::string Input_para::vdw_R0_unit = "A" |
unit of R0, A or Bohr
| std::string Input_para::vdw_radius_unit = "Bohr" |
unit of radius cutoff for periodic structure
| std::string Input_para::vdw_s6 = "default" |
scale parameter of d2/d3_0/d3_bj
| std::string Input_para::vdw_s8 = "default" |
scale parameter of d3_0/d3_bj
| bool Input_para::vh_in_h = true |
calculate the hartree potential or not
| bool Input_para::vion_in_h = true |
calculate the local ionic potential or not //only relevant when vl_in_h = 1
| bool Input_para::vl_in_h = true |
calculate the vloc or not.
| bool Input_para::vnl_in_h = true |
calculate the vnl or not.
| int Input_para::wannier_method = 1 |
different implementation methods under Lcao basis set
| std::string Input_para::wannier_spin = "up" |
add by jingan for wannier90: calculate spin in wannier90 code interface
| std::vector<double> Input_para::xc_corr_ext |
| std::vector<double> Input_para::xc_exch_ext |
| std::string Input_para::xc_kernel = "LDA" |
exchange correlation (XC) kernel for LR-TDDFT
| double Input_para::xc_temperature = 0.0 |
only relevant if finite temperature functional is used
| double Input_para::yukawa_lambda = -1.0 |
default: -1.0, which means we calculate lambda
| bool Input_para::yukawa_potential = false |
default: false
| double Input_para::zgate = 0.5 |
position of charged plate