Coverage for /builds/ase/ase/ase/io/espresso_namelist/keys.py: 100.00%

36 statements  

« prev     ^ index     » next       coverage.py v7.5.3, created at 2025-08-02 00:12 +0000

1# fmt: off 

2 

3pw_keys = { 

4 "control": [ 

5 "calculation", 

6 "title", 

7 "verbosity", 

8 "restart_mode", 

9 "wf_collect", 

10 "nstep", 

11 "iprint", 

12 "tstress", 

13 "tprnfor", 

14 "dt", 

15 "outdir", 

16 "wfcdir", 

17 "prefix", 

18 "lkpoint_dir", 

19 "max_seconds", 

20 "etot_conv_thr", 

21 "forc_conv_thr", 

22 "disk_io", 

23 "pseudo_dir", 

24 "tefield", 

25 "dipfield", 

26 "lelfield", 

27 "nberrycyc", 

28 "lorbm", 

29 "lberry", 

30 "gdir", 

31 "nppstr", 

32 "gate", 

33 "twochem", 

34 "lfcp", 

35 "trism" 

36 ], 

37 "system": [ 

38 "ibrav", 

39 "celldm", 

40 "a", 

41 "b", 

42 "c", 

43 "cosab", 

44 "cosac", 

45 "cosbc", 

46 "nat", 

47 "ntyp", 

48 "nbnd", 

49 "nbnd_cond", 

50 "tot_charge", 

51 "starting_charge", 

52 "tot_magnetization", 

53 "starting_magnetization", 

54 "ecutwfc", 

55 "ecutrho", 

56 "ecutfock", 

57 "nr1", 

58 "nr2", 

59 "nr3", 

60 "nr1s", 

61 "nr2s", 

62 "nr3s", 

63 "nosym", 

64 "nosym_evc", 

65 "noinv", 

66 "no_t_rev", 

67 "force_symmorphic", 

68 "use_all_frac", 

69 "occupations", 

70 "one_atom_occupations", 

71 "starting_spin_angle", 

72 "degauss_cond", 

73 "nelec_cond", 

74 "degauss", 

75 "smearing", 

76 "nspin", 

77 "sic_gamma", 

78 "pol_type", 

79 "sic_energy", 

80 "sci_vb", 

81 "sci_cb", 

82 "noncolin", 

83 "ecfixed", 

84 "qcutz", 

85 "q2sigma", 

86 "input_dft", 

87 "ace", 

88 "exx_fraction", 

89 "screening_parameter", 

90 "exxdiv_treatment", 

91 "x_gamma_extrapolation", 

92 "ecutvcut", 

93 "nqx1", 

94 "nqx2", 

95 "nqx3", 

96 "localization_thr", 

97 "hubbard_occ", 

98 "hubbard_alpha", 

99 "hubbard_beta", 

100 "starting_ns_eigenvalue", 

101 "dmft", 

102 "dmft_prefix", 

103 "ensemble_energies", 

104 "edir", 

105 "emaxpos", 

106 "eopreg", 

107 "eamp", 

108 "angle1", 

109 "angle2", 

110 "lforcet", 

111 "constrained_magnetization", 

112 "fixed_magnetization", 

113 "lambda", 

114 "report", 

115 "lspinorb", 

116 "assume_isolated", 

117 "esm_bc", 

118 "esm_w", 

119 "esm_efield", 

120 "esm_nfit", 

121 "lgcscf", 

122 "gcscf_mu", 

123 "gcscf_conv_thr", 

124 "gcscf_beta", 

125 "vdw_corr", 

126 "london", 

127 "london_s6", 

128 "london_c6", 

129 "london_rvdw", 

130 "london_rcut", 

131 "dftd3_version", 

132 "dftd3_threebody", 

133 "ts_vdw_econv_thr", 

134 "ts_vdw_isolated", 

135 "xdm", 

136 "xdm_a1", 

137 "xdm_a2", 

138 "space_group", 

139 "uniqueb", 

140 "origin_choice", 

141 "rhombohedral", 

142 "zgate", 

143 "relaxz", 

144 "block", 

145 "block_1", 

146 "block_2", 

147 "block_height", 

148 "nextffield" 

149 ], 

150 "electrons": [ 

151 "electron_maxstep", 

152 "exx_maxstep", 

153 "scf_must_converge", 

154 "conv_thr", 

155 "adaptive_thr", 

156 "conv_thr_init", 

157 "conv_thr_multi", 

158 "mixing_mode", 

159 "mixing_beta", 

160 "mixing_ndim", 

161 "mixing_fixed_ns", 

162 "diagonalization", 

163 "diago_thr_init", 

164 "diago_cg_maxiter", 

165 "diago_ppcg_maxiter", 

166 "diago_david_ndim", 

167 "diago_rmm_ndim", 

168 "diago_rmm_conv", 

169 "diago_gs_nblock", 

170 "diago_full_acc", 

171 "efield", 

172 "efield_cart", 

173 "efield_phase", 

174 "startingpot", 

175 "startingwfc", 

176 "tqr", 

177 "real_space" 

178 ], 

179 "ions": [ 

180 "ion_positions", 

181 "ion_velocities", 

182 "ion_dynamics", 

183 "pot_extrapolation", 

184 "wfc_extrapolation", 

185 "remove_rigid_rot", 

186 "ion_temperature", 

187 "tempw", 

188 "tolp", 

189 "delta_t", 

190 "nraise", 

191 "refold_pos", 

192 "upscale", 

193 "bfgs_ndim", 

194 "trust_radius_max", 

195 "trust_radius_min", 

196 "trust_radius_ini", 

197 "w_1", 

198 "w_2", 

199 "fire_alpha_init", 

200 "fire_falpha", 

201 "fire_nmin", 

202 "fire_f_inc", 

203 "fire_f_dec", 

204 "fire_dtmax" 

205 ], 

206 "cell": [ 

207 "cell_dynamics", 

208 "press", 

209 "wmass", 

210 "cell_factor", 

211 "press_conv_thr", 

212 "cell_dofree" 

213 ], 

214 "fcp": [ 

215 "fcp_mu", 

216 "fcp_dynamics", 

217 "fcp_conv_thr", 

218 "fcp_ndiis", 

219 "fcp_mass", 

220 "fcp_velocity", 

221 "fcp_temperature", 

222 "fcp_tempw", 

223 "fcp_tolp", 

224 "fcp_delta_t", 

225 "fcp_nraise", 

226 "freeze_all_atoms" 

227 ], 

228 "rism": [ 

229 "nsolv", 

230 "closure", 

231 "tempv", 

232 "ecutsolv", 

233 "solute_lj", 

234 "solute_epsilon", 

235 "solute_sigma", 

236 "starting1d", 

237 "starting3d", 

238 "smear1d", 

239 "smear3d", 

240 "rism1d_maxstep", 

241 "rism3d_maxstep", 

242 "rism1d_conv_thr", 

243 "rism3d_conv_thr", 

244 "mdiis1d_size", 

245 "mdiis3d_size", 

246 "mdiis1d_step", 

247 "mdiis3d_step", 

248 "rism1d_bond_width", 

249 "rism1d_dielectric", 

250 "rism1d_molesize", 

251 "rism1d_nproc", 

252 "rism3d_conv_level", 

253 "rism3d_planar_average", 

254 "laue_nfit", 

255 "laue_expand_right", 

256 "laue_expand_left", 

257 "laue_starting_right", 

258 "laue_starting_left", 

259 "laue_buffer_right", 

260 "laue_buffer_left", 

261 "laue_both_hands", 

262 "laue_wall", 

263 "laue_wall_z", 

264 "laue_wall_rho", 

265 "laue_wall_epsilon", 

266 "laue_wall_sigma", 

267 "laue_wall_lj6" 

268 ] 

269} 

270 

271ph_keys = { 

272 "inputph": [ 

273 "amass", 

274 "outdir", 

275 "prefix", 

276 "niter_ph", 

277 "tr2_ph", 

278 "alpha_mix", 

279 "nmix_ph", 

280 "verbosity", 

281 "reduce_io", 

282 "max_seconds", 

283 "dftd3_hess", 

284 "fildyn", 

285 "fildrho", 

286 "fildvscf", 

287 "epsil", 

288 "lrpa", 

289 "lnoloc", 

290 "trans", 

291 "lraman", 

292 "eth_rps", 

293 "eth_ns", 

294 "dek", 

295 "recover", 

296 "low_directory_check", 

297 "only_init", 

298 "qplot", 

299 "q2d", 

300 "q_in_band_form", 

301 "electron_phonon", 

302 "el_ph_nsigma", 

303 "el_ph_sigma", 

304 "ahc_dir", 

305 "ahc_nbnd", 

306 "ahc_nbndskip", 

307 "skip_upperfan", 

308 "lshift_q", 

309 "zeu", 

310 "zue", 

311 "elop", 

312 "fpol", 

313 "ldisp", 

314 "nogg", 

315 "asr", 

316 "ldiag", 

317 "lqdir", 

318 "search_sym", 

319 "nq1", 

320 "nq2", 

321 "nq3", 

322 "nk1", 

323 "nk2", 

324 "nk3", 

325 "k1", 

326 "k2", 

327 "k3", 

328 "diagonalization", 

329 "read_dns_bare", 

330 "ldvscf_interpolate", 

331 "wpot_dir", 

332 "do_long_range", 

333 "do_charge_neutral", 

334 "start_irr", 

335 "last_irr", 

336 "nat_todo", 

337 "modenum", 

338 "start_q", 

339 "last_q", 

340 "dvscf_star", 

341 "drho_star", 

342 ] 

343} 

344 

345pp_keys = { 

346 "inputpp": [ 

347 "prefix", 

348 "outdir", 

349 "filplot", 

350 "plot_num", 

351 "spin_component", 

352 "spin_component", 

353 "emin", 

354 "emax", 

355 "delta_e", 

356 "degauss_ldos", 

357 "use_gauss_ldos", 

358 "sample_bias", 

359 "kpoint", 

360 "kband", 

361 "lsign", 

362 "spin_component", 

363 "emin", 

364 "emax", 

365 "spin_component", 

366 "spin_component", 

367 "spin_component", 

368 "spin_component", 

369 ], 

370 "plot": [ 

371 "nfile", 

372 "filepp", 

373 "weight", 

374 "iflag", 

375 "output_format", 

376 "fileout", 

377 "interpolation", 

378 "e1", 

379 "x0", 

380 "nx", 

381 "e1", 

382 "e2", 

383 "x0", 

384 "nx", 

385 "ny", 

386 "e1", 

387 "e2", 

388 "e3", 

389 "x0", 

390 "nx", 

391 "ny", 

392 "nz", 

393 "radius", 

394 "nx", 

395 "ny", 

396 ], 

397} 

398 

399matdyn_keys = { 

400 "input": [ 

401 "flfrc", 

402 "asr", 

403 "huang", 

404 "dos", 

405 "nk1", 

406 "nk2", 

407 "nk3", 

408 "deltae", 

409 "ndos", 

410 "degauss", 

411 "fldos", 

412 "flfrq", 

413 "flvec", 

414 "fleig", 

415 "fldyn", 

416 "at", 

417 "l1", 

418 "l2", 

419 "l3", 

420 "ntyp", 

421 "amass", 

422 "readtau", 

423 "fltau", 

424 "la2f", 

425 "q_in_band_form", 

426 "q_in_cryst_coord", 

427 "eigen_similarity", 

428 "fd", 

429 "na_ifc", 

430 "nosym", 

431 "loto_2d", 

432 "loto_disable", 

433 "read_lr", 

434 "write_frc", 

435 ] 

436} 

437 

438 

439dynmat_keys = { 

440 "input": [ 

441 "fildyn", 

442 "q", 

443 "amass", 

444 "asr", 

445 "remove_interaction_blocks", 

446 "axis", 

447 "lperm", 

448 "lplasma", 

449 "filout", 

450 "fileig", 

451 "filmol", 

452 "filxsf", 

453 "loto_2d", 

454 "el_ph_nsig", 

455 "el_ph_sigma", 

456 ] 

457} 

458 

459 

460q2r_keys = {"input": ["fildyn", "flfrc", "zasr", "loto_2d", "write_lr"]} 

461 

462dos_keys = { 

463 "dos": [ 

464 "prefix", 

465 "outdir", 

466 "bz_sum", 

467 "ngauss", 

468 "degauss", 

469 "emin", 

470 "emax", 

471 "deltae", 

472 "fildos", 

473 ] 

474} 

475 

476 

477bands_keys = { 

478 "bands": [ 

479 "prefix", 

480 "outdir", 

481 "filband", 

482 "spin_component", 

483 "lsigma", 

484 "lp", 

485 "filp", 

486 "lsym", 

487 "no_overlap", 

488 "plot_2d", 

489 "firstk", 

490 "lastk", 

491 ] 

492} 

493 

494 

495band_interpolation_keys = { 

496 "interpolation": [ 

497 "method", 

498 "miller_max", 

499 "check_periodicity", 

500 "p_metric", 

501 "scale_sphere", 

502 ] 

503} 

504 

505 

506projwfc_keys = { 

507 "projwfc": [ 

508 "prefix", 

509 "outdir", 

510 "ngauss", 

511 "degauss", 

512 "emin", 

513 "emax", 

514 "deltae", 

515 "lsym", 

516 "diag_basis", 

517 "pawproj", 

518 "filpdos", 

519 "filproj", 

520 "lwrite_overlaps", 

521 "lbinary_data", 

522 "kresolveddos", 

523 "tdosinboxes", 

524 "n_proj_boxes", 

525 "irmin", 

526 "irmax", 

527 "plotboxes", 

528 ] 

529} 

530 

531 

532molecularpdos_keys = { 

533 "inputmopdos": [ 

534 "xmlfile_full", 

535 "xmlfile_part", 

536 "i_atmwfc_beg_full", 

537 "i_atmwfc_end_full", 

538 "i_atmwfc_beg_part", 

539 "i_atmwfc_end_part", 

540 "i_bnd_beg_full", 

541 "i_bnd_end_full", 

542 "i_bnd_beg_part", 

543 "i_bnd_end_part", 

544 "fileout", 

545 "ngauss", 

546 "degauss", 

547 "emin", 

548 "emax", 

549 "deltae", 

550 "kresolveddos", 

551 ] 

552} 

553 

554 

555importexport_binary_keys = { 

556 "inputpp": [ 

557 "prefix", 

558 "outdir", 

559 "direction", 

560 "newoutdir"]} 

561 

562 

563oscdft_pp_keys = {"oscdft_pp_namelist": ["prefix", "outdir"]} 

564 

565kcw_keys = { 

566 "control": [ 

567 "prefix", 

568 "outdir", 

569 "calculation", 

570 "kcw_iverbosity", 

571 "kcw_at_ks", 

572 "read_unitary_matrix", 

573 "spread_thr", 

574 "homo_only", 

575 "l_vcut", 

576 "assume_isolated", 

577 "spin_component", 

578 "mp1", 

579 "mp2", 

580 "mp3", 

581 "lrpa", 

582 ], 

583 "wannier": [ 

584 "seedname", 

585 "num_wann_occ", 

586 "num_wann_emp", 

587 "have_empty", 

588 "has_disentangle", 

589 "check_ks", 

590 ], 

591 "screen": ["niter", "nmix", "tr2", "i_orb", "eps_inf", "check_spread"], 

592 "ham": ["do_bands", "use_ws_distance", "write_hr", "on_site_only"], 

593} 

594 

595 

596cppp_keys = { 

597 "inputpp": [ 

598 "prefix", 

599 "fileout", 

600 "output", 

601 "outdir", 

602 "lcharge", 

603 "lforces", 

604 "ldynamics", 

605 "lpdb", 

606 "lrotation", 

607 "np1", 

608 "np2", 

609 "np3", 

610 "nframes", 

611 "ndr", 

612 "atomic_number", 

613 ] 

614} 

615 

616 

617ppacf_keys = { 

618 "ppacf": [ 

619 "prefix", 

620 "outdir", 

621 "n_lambda", 

622 "lplot", 

623 "ltks", 

624 "lfock", 

625 "use_ace", 

626 "code_num", 

627 "vdw_analysis", 

628 ] 

629} 

630 

631 

632all_currents_keys = { 

633 "energy_current": [ 

634 "delta_t", 

635 "file_output", 

636 "trajdir", 

637 "vel_input_units", 

638 "eta", 

639 "n_max", 

640 "first_step", 

641 "last_step", 

642 "step_mul", 

643 "step_rem", 

644 "ethr_small_step", 

645 "ethr_big_step", 

646 "restart", 

647 "subtract_cm_vel", 

648 "add_i_current_b", 

649 "save_dvpsi", 

650 "re_init_wfc_1", 

651 "re_init_wfc_2", 

652 "re_init_wfc_3", 

653 "three_point_derivative", 

654 "n_repeat_every_step", 

655 "n_workers", 

656 "worker_id", 

657 "continue_not_converged", 

658 ] 

659} 

660 

661 

662turbo_lanczos_keys = { 

663 "lr_input": [ 

664 "prefix", 

665 "outdir", 

666 "wfcdir", 

667 "restart", 

668 "restart_step", 

669 "lr_verbosity", 

670 "disk_io", 

671 ], 

672 "lr_control": [ 

673 "itermax", 

674 "ipol", 

675 "n_ipol", 

676 "ltammd", 

677 "no_hxc", 

678 "lrpa", 

679 "scissor", 

680 "charge_response", 

681 "pseudo_hermitian", 

682 "d0psi_rs", 

683 "lshift_d0psi", 

684 ], 

685 "lr_post": [ 

686 "omeg", 

687 "epsil", 

688 "beta_gamma_z_prefix", 

689 "w_t_npol", 

690 "plot_type"], 

691} 

692 

693 

694turbo_spectrum_keys = { 

695 "lr_input": [ 

696 "prefix", 

697 "outdir", 

698 "verbosity", 

699 "itermax0", 

700 "itermax", 

701 "extrapolation", 

702 "epsil", 

703 "units", 

704 "start", 

705 "end", 

706 "increment", 

707 "ipol", 

708 "eels", 

709 "magnons", 

710 "td", 

711 "eign_file", 

712 ] 

713} 

714 

715 

716turbo_davidson_keys = { 

717 "lr_input": [ 

718 "prefix", 

719 "outdir", 

720 "wfcdir", 

721 "max_seconds", 

722 "restart", 

723 "lr_verbosity", 

724 "disk_io", 

725 ], 

726 "lr_dav": [ 

727 "num_eign", 

728 "num_init", 

729 "if_random_init", 

730 "num_basis_max", 

731 "residue_conv_thr", 

732 "precondition", 

733 "single_pole", 

734 "if_dft_spectrum", 

735 "reference", 

736 "broadening", 

737 "start", 

738 "finish", 

739 "step", 

740 "p_nbnd_occ", 

741 "p_nbnd_virt", 

742 "poor_of_ram", 

743 "poor_of_ram2", 

744 "max_iter", 

745 "no_hxc", 

746 "pseudo_hermitian", 

747 "ltammd", 

748 "lplot_drho", 

749 "d0psi_rs", 

750 "lshift_d0psi", 

751 ], 

752} 

753 

754 

755turbo_magnon_keys = { 

756 "lr_input": [ 

757 "prefix", 

758 "outdir", 

759 "restart", 

760 "restart_step", 

761 "lr_verbosity", 

762 "disk_io", 

763 ], 

764 "lr_control": [ 

765 "itermax", 

766 "pseudo_hermitian", 

767 "approximation", 

768 "ipol", 

769 "q1", 

770 "q2", 

771 "q3", 

772 ], 

773} 

774 

775 

776turbo_eels_keys = { 

777 "lr_input": [ 

778 "prefix", 

779 "outdir", 

780 "restart", 

781 "restart_step", 

782 "lr_verbosity", 

783 "disk_io", 

784 ], 

785 "lr_control": [ 

786 "approximation", 

787 "q1", 

788 "q2", 

789 "q3", 

790 "calculator", 

791 "itermax", 

792 "pseudo_hermitian", 

793 "alpha_mix(i", 

794 "epsil", 

795 "units", 

796 "start", 

797 "end", 

798 "increment", 

799 "ethr_nscf", 

800 ], 

801} 

802 

803 

804oscdft_et_keys = { 

805 "oscdft_et_namelist": [ 

806 "initial_prefix", 

807 "final_prefix", 

808 "initial_dir", 

809 "final_dir", 

810 "print_matrix", 

811 "print_eigvect", 

812 "print_debug", 

813 ] 

814} 

815 

816 

817pprism_keys = { 

818 "inputpp": ["prefix", "outdir", "filplot", "lpunch"], 

819 "plot": [ 

820 "iflag", 

821 "output_format", 

822 "fileout", 

823 "interpolation", 

824 "x0", 

825 "nx", 

826 "lebedev", 

827 "e1", 

828 "x0", 

829 "nx", 

830 "e1", 

831 "e2", 

832 "x0", 

833 "nx", 

834 "ny", 

835 "e1", 

836 "e2", 

837 "e3", 

838 "x0", 

839 "nx", 

840 "ny", 

841 "nz", 

842 "radius", 

843 "nx", 

844 "ny", 

845 ], 

846} 

847 

848 

849pwcond_keys = { 

850 "inputcond": [ 

851 "outdir", 

852 "prefixt", 

853 "prefixl", 

854 "prefixs", 

855 "prefixr", 

856 "tran_prefix", 

857 "max_seconds", 

858 "recover", 

859 "band_file", 

860 "tran_file", 

861 "save_file", 

862 "fil_loc", 

863 "lwrite_cond", 

864 "loop_ek", 

865 "lread_cond", 

866 "lwrite_loc", 

867 "lread_loc", 

868 "ikind", 

869 "iofspin", 

870 "tk_plot", 

871 "llocal", 

872 "bdl", 

873 "bds", 

874 "bdr", 

875 "nz1", 

876 "energy0", 

877 "denergy", 

878 "nenergy", 

879 "start_e", 

880 "last_e", 

881 "start_k", 

882 "last_k", 

883 "ecut2d", 

884 "ewind", 

885 "epsproj", 

886 "orbj_in", 

887 "orbj_fin", 

888 ] 

889} 

890 

891 

892pw2bgw_keys = { 

893 "input_pw2bgw": [ 

894 "prefix", 

895 "outdir", 

896 "real_or_complex", 

897 "symm_type", 

898 "wfng_flag", 

899 "wfng_file", 

900 "wfng_kgrid", 

901 "wfng_nk1", 

902 "wfng_nk2", 

903 "wfng_nk3", 

904 "wfng_dk1", 

905 "wfng_dk2", 

906 "wfng_dk3", 

907 "wfng_occupation", 

908 "wfng_nvmin", 

909 "wfng_nvmax", 

910 "rhog_flag", 

911 "rhog_file", 

912 "rhog_nvmin", 

913 "rhog_nvmax", 

914 "vxcg_flag", 

915 "vxcg_file", 

916 "vxc0_flag", 

917 "vxc0_file", 

918 "vxc_flag", 

919 "vxc_file", 

920 "vxc_integral", 

921 "vxc_diag_nmin", 

922 "vxc_diag_nmax", 

923 "vxc_offdiag_nmin", 

924 "vxc_offdiag_nmax", 

925 "vxc_zero_rho_core", 

926 "vscg_flag", 

927 "vscg_file", 

928 "vkbg_flag", 

929 "vkbg_file", 

930 ] 

931} 

932 

933 

934bgw2pw_keys = { 

935 "input_bgw2pw": [ 

936 "prefix", 

937 "outdir", 

938 "real_or_complex", 

939 "wfng_flag", 

940 "wfng_file", 

941 "wfng_nband", 

942 "rhog_flag", 

943 "rhog_file", 

944 ] 

945} 

946 

947 

948hp_keys = { 

949 "inputhp": [ 

950 "prefix", 

951 "outdir", 

952 "iverbosity", 

953 "max_seconds", 

954 "nq1", 

955 "nq2", 

956 "nq3", 

957 "skip_equivalence_q", 

958 "determine_num_pert_only", 

959 "determine_q_mesh_only", 

960 "find_atpert", 

961 "docc_thr", 

962 "skip_type", 

963 "equiv_type", 

964 "perturb_only_atom", 

965 "start_q", 

966 "last_q", 

967 "sum_pertq", 

968 "compute_hp", 

969 "conv_thr_chi", 

970 "thresh_init", 

971 "ethr_nscf", 

972 "niter_max", 

973 "alpha_mix(i", 

974 "nmix", 

975 "num_neigh", 

976 "lmin", 

977 "rmax", 

978 "dist_thr", 

979 ] 

980} 

981 

982 

983cp_keys = { 

984 "control": [ 

985 "calculation", 

986 "title", 

987 "verbosity", 

988 "isave", 

989 "restart_mode", 

990 "nstep", 

991 "iprint", 

992 "tstress", 

993 "tprnfor", 

994 "dt", 

995 "outdir", 

996 "saverho", 

997 "prefix", 

998 "ndr", 

999 "ndw", 

1000 "tabps", 

1001 "max_seconds", 

1002 "etot_conv_thr", 

1003 "forc_conv_thr", 

1004 "ekin_conv_thr", 

1005 "disk_io", 

1006 "memory", 

1007 "pseudo_dir", 

1008 "tefield", 

1009 ], 

1010 "system": [ 

1011 "ibrav", 

1012 "celldm", 

1013 "a", 

1014 "b", 

1015 "c", 

1016 "cosab", 

1017 "cosac", 

1018 "cosbc", 

1019 "nat", 

1020 "ntyp", 

1021 "nbnd", 

1022 "tot_charge", 

1023 "tot_magnetization", 

1024 "ecutwfc", 

1025 "ecutrho", 

1026 "nr1", 

1027 "nr2", 

1028 "nr3", 

1029 "nr1s", 

1030 "nr2s", 

1031 "nr3s", 

1032 "nr1b", 

1033 "nr2b", 

1034 "nr3b", 

1035 "occupations", 

1036 "degauss", 

1037 "smearing", 

1038 "nspin", 

1039 "ecfixed", 

1040 "qcutz", 

1041 "q2sigma", 

1042 "input_dft", 

1043 "exx_fraction", 

1044 "lda_plus_u", 

1045 "hubbard_u", 

1046 "vdw_corr", 

1047 "london_s6", 

1048 "london_rcut", 

1049 "ts_vdw", 

1050 "ts_vdw_econv_thr", 

1051 "ts_vdw_isolated", 

1052 "assume_isolated", 

1053 ], 

1054 "electrons": [ 

1055 "electron_maxstep", 

1056 "electron_dynamics", 

1057 "conv_thr", 

1058 "niter_cg_restart", 

1059 "efield", 

1060 "epol", 

1061 "emass", 

1062 "emass_cutoff", 

1063 "orthogonalization", 

1064 "ortho_eps", 

1065 "ortho_max", 

1066 "ortho_para", 

1067 "electron_damping", 

1068 "electron_velocities", 

1069 "electron_temperature", 

1070 "ekincw", 

1071 "fnosee", 

1072 "startingwfc", 

1073 "tcg", 

1074 "maxiter", 

1075 "passop", 

1076 "pre_state", 

1077 "n_inner", 

1078 "niter_cold_restart", 

1079 "lambda_cold", 

1080 "grease", 

1081 "ampre", 

1082 ], 

1083 "ions": [ 

1084 "ion_dynamics", 

1085 "ion_positions", 

1086 "ion_velocities", 

1087 "ion_damping", 

1088 "ion_radius", 

1089 "iesr", 

1090 "ion_nstepe", 

1091 "remove_rigid_rot", 

1092 "ion_temperature", 

1093 "tempw", 

1094 "fnosep", 

1095 "tolp", 

1096 "nhpcl", 

1097 "nhptyp", 

1098 "nhgrp", 

1099 "fnhscl", 

1100 "ndega", 

1101 "tranp", 

1102 "amprp", 

1103 "greasp", 

1104 ], 

1105 "cell": [ 

1106 "cell_parameters", 

1107 "cell_dynamics", 

1108 "cell_velocities", 

1109 "cell_damping", 

1110 "press", 

1111 "wmass", 

1112 "cell_factor", 

1113 "cell_temperature", 

1114 "temph", 

1115 "fnoseh", 

1116 "greash", 

1117 "cell_dofree", 

1118 ], 

1119 "press_ai": [ 

1120 "abivol", 

1121 "abisur", 

1122 "p_ext", 

1123 "pvar", 

1124 "p_in", 

1125 "p_fin", 

1126 "surf_t", 

1127 "rho_thr", 

1128 "dthr", 

1129 ], 

1130 "wannier": [ 

1131 "wf_efield", 

1132 "wf_switch", 

1133 "sw_len", 

1134 "efx0", 

1135 "efy0", 

1136 "efz0", 

1137 "efx1", 

1138 "efy1", 

1139 "efz1", 

1140 "wfsd", 

1141 "wfdt", 

1142 "maxwfdt", 

1143 "nit", 

1144 "nsd", 

1145 "wf_q", 

1146 "wf_friction", 

1147 "nsteps", 

1148 "tolw", 

1149 "adapt", 

1150 "calwf", 

1151 "nwf", 

1152 "wffort", 

1153 "writev", 

1154 "exx_neigh", 

1155 "exx_dis_cutoff", 

1156 "exx_poisson_eps", 

1157 "exx_use_cube_domain", 

1158 "exx_ps_rcut_self", 

1159 "exx_ps_rcut_pair", 

1160 "exx_me_rcut_self", 

1161 "exx_me_rcut_pair", 

1162 ], 

1163} 

1164 

1165 

1166ld1_keys = { 

1167 "input": [ 

1168 "title", 

1169 "zed", 

1170 "atom", 

1171 "xmin", 

1172 "dx", 

1173 "rmax", 

1174 "beta", 

1175 "tr2", 

1176 "iswitch", 

1177 "nld", 

1178 "rlderiv", 

1179 "eminld", 

1180 "emaxld", 

1181 "deld", 

1182 "rpwe", 

1183 "rel", 

1184 "lsmall", 

1185 "max_out_wfc", 

1186 "noscf", 

1187 "lsd", 

1188 "dft", 

1189 "latt", 

1190 "isic", 

1191 "rytoev_fact", 

1192 "cau_fact", 

1193 "vdw", 

1194 "prefix", 

1195 "verbosity", 

1196 "file_charge", 

1197 "config", 

1198 "relpert", 

1199 "rel_dist", 

1200 "write_coulomb", 

1201 ], 

1202 "inputp": [ 

1203 "zval", 

1204 "pseudotype", 

1205 "file_pseudopw", 

1206 "file_recon", 

1207 "lloc", 

1208 "rcloc", 

1209 "nlcc", 

1210 "new_core_ps", 

1211 "rcore", 

1212 "tm", 

1213 "rho0", 

1214 "lpaw", 

1215 "which_augfun", 

1216 "rmatch_augfun", 

1217 "rmatch_augfun_nc", 

1218 "lsave_wfc", 

1219 "lgipaw_reconstruction", 

1220 "use_paw_as_gipaw", 

1221 "author", 

1222 "file_chi", 

1223 "file_beta", 

1224 "file_qvan", 

1225 "file_screen", 

1226 "file_core", 

1227 "file_wfcaegen", 

1228 "file_wfcncgen", 

1229 "file_wfcusgen", 

1230 ], 

1231 "test": [ 

1232 "nconf", 

1233 "file_pseudo", 

1234 "ecutmin", 

1235 "ecutmax", 

1236 "decut", 

1237 "rm", 

1238 "configts", 

1239 "lsdts", 

1240 "frozen_core", 

1241 "rcutv", 

1242 ], 

1243} 

1244 

1245 

1246d3hess_keys = {"input": ["prefix", "outdir", "filhess", "step"]} 

1247 

1248neb_keys = { 

1249 "path": [ 

1250 "string_method", 

1251 "restart_mode", 

1252 "nstep_path", 

1253 "num_of_images", 

1254 "opt_scheme", 

1255 "ci_scheme", 

1256 "first_last_opt", 

1257 "minimum_image", 

1258 "temp_req", 

1259 "ds", 

1260 "k_max", 

1261 "k_min", 

1262 "path_thr", 

1263 "use_masses", 

1264 "use_freezing", 

1265 "lfcp", 

1266 "fcp_mu", 

1267 "fcp_thr", 

1268 "fcp_scheme", 

1269 ] 

1270} 

1271 

1272postahc_keys = { 

1273 "input": [ 

1274 "ahc_dir", 

1275 "nk", 

1276 "nbnd", 

1277 "nat", 

1278 "nq", 

1279 "ahc_nbnd", 

1280 "ahc_nbndskip", 

1281 "flvec", 

1282 "eta", 

1283 "temp_kelvin", 

1284 "efermi", 

1285 "amass_amu", 

1286 "skip_upperfan", 

1287 "skip_dw" 

1288 ] 

1289} 

1290 

1291dvscf_q2r = { 

1292 "input": [ 

1293 "prefix", 

1294 "outdir", 

1295 "fildyn", 

1296 "fildvscf", 

1297 "wpot_dir", 

1298 "do_long_range", 

1299 "do_charge_neutral", 

1300 "verbosity" 

1301 ] 

1302} 

1303 

1304epw_keys = { 

1305 "inputepw": [ 

1306 "adapt_ethrdg_plrn", 

1307 "a2f", 

1308 "amass", 

1309 "asr_typ", 

1310 "assume_metal", 

1311 "band_plot", 

1312 "bands_skipped", 

1313 "bfieldx", 

1314 "bfieldy", 

1315 "bfieldz", 

1316 "bnd_cum", 

1317 "broyden_beta", 

1318 "broyden_ndim", 

1319 "cal_psir_plrn", 

1320 "carrier", 

1321 "conv_thr_iaxis", 

1322 "conv_thr_plrn", 

1323 "conv_thr_racon", 

1324 "conv_thr_raxis", 

1325 "cumulant", 

1326 "degaussq", 

1327 "degaussw", 

1328 "delta_approx", 

1329 "delta_qsmear", 

1330 "delta_smear", 

1331 "dvscf_dir", 

1332 "do_CHBB", 

1333 "efermi_read", 

1334 "eig_read", 

1335 "elecselfen", 

1336 "eliashberg", 

1337 "elph", 

1338 "ep_coupling", 

1339 "epbwrite", 

1340 "epbread", 

1341 "epexst", 

1342 "ephwrite", 

1343 "epmatkqread", 

1344 "eps_acustic", 

1345 "epsiHEG", 

1346 "epwread", 

1347 "epwwrite", 

1348 "etf_mem", 

1349 "ethrdg_plrn", 

1350 "fermi_diff", 

1351 "fermi_energy", 

1352 "fermi_plot", 

1353 "fila2f", 

1354 "fildvscf", 

1355 "filkf", 

1356 "filqf", 

1357 "filukk", 

1358 "filukq", 

1359 "fixsym", 

1360 "fsthick", 

1361 "gap_edge", 

1362 "gb_scattering", 

1363 "gb_only", 

1364 "gb_size", 

1365 "imag_read", 

1366 "init_ethrdg_plrn", 

1367 "init_k0_plrn", 

1368 "init_ntau_plrn", 

1369 "init_plrn", 

1370 "init_sigma_plrn", 

1371 "interp_Ank_plrn", 

1372 "interp_Bqu_plrn", 

1373 "int_mob", 

1374 "io_lvl_plrn", 

1375 "iterative_bte", 

1376 "iverbosity", 

1377 "ii_g", 

1378 "ii_scattering", 

1379 "ii_only", 

1380 "ii_lscreen", 

1381 "ii_partion", 

1382 "ii_charge", 

1383 "ii_n", 

1384 "ii_eda", 

1385 "kerread", 

1386 "kerwrite", 

1387 "kmaps", 

1388 "lacon", 

1389 "laniso", 

1390 "lifc", 

1391 "limag", 

1392 "lindabs", 

1393 "liso", 

1394 "longrange", 

1395 "lpade", 

1396 "lphase", 

1397 "lpolar", 

1398 "lreal", 

1399 "lscreen", 

1400 "lunif", 

1401 "loptabs", 

1402 "len_mesh", 

1403 "max_memlt", 

1404 "meff", 

1405 "mob_maxiter", 

1406 "mp_mesh_k", 

1407 "mp_mesh_q", 

1408 "muc", 

1409 "meshnum", 

1410 "nbndsub", 

1411 "ncarrier", 

1412 "nc", 

1413 "nel", 

1414 "nest_fn", 

1415 "nethrdg_plrn", 

1416 "ngaussw", 

1417 "niter_plrn", 

1418 "nk1", 

1419 "nk2", 

1420 "nk3", 

1421 "nkf1", 

1422 "nkf2", 

1423 "nkf3", 

1424 "nq1", 

1425 "nq2", 

1426 "nq3", 

1427 "nqf1", 

1428 "nqf2", 

1429 "nqf3", 

1430 "npade", 

1431 "nqsmear", 

1432 "nqstep", 

1433 "n_r", 

1434 "nsiter", 

1435 "nsmear", 

1436 "nstemp", 

1437 "nswi", 

1438 "nswc", 

1439 "nswfc", 

1440 "nw", 

1441 "nw_specfun", 

1442 "nq_init", 

1443 "omegamax", 

1444 "omegamin", 

1445 "omegastep", 

1446 "phonselfen", 

1447 "plselfen", 

1448 "plrn", 

1449 "prefix", 

1450 "prtgkk", 

1451 "pwc", 

1452 "QD_bin", 

1453 "QD_min", 

1454 "rand_nq", 

1455 "rand_nk", 

1456 "rand_q", 

1457 "rand_k", 

1458 "restart", 

1459 "restart_filq", 

1460 "restart_plrn", 

1461 "restart_step", 

1462 "scell_mat", 

1463 "scell_mat_plrn", 

1464 "scr_typ", 

1465 "scatread", 

1466 "scattering", 

1467 "scattering_serta", 

1468 "scattering_0rta", 

1469 "scissor", 

1470 "selecqread", 

1471 "smear_rpa", 

1472 "specfun_el", 

1473 "specfun_ph", 

1474 "specfun_pl", 

1475 "system_2d", 

1476 "shortrange", 

1477 "step_wf_grid_plrn", 

1478 "start_mesh", 

1479 "temps", 

1480 "tc_linear", 

1481 "tc_linear_solver", 

1482 "type_plrn", 

1483 "vme", 

1484 "wannierize", 

1485 "wepexst", 

1486 "wmax", 

1487 "wmax_specfun", 

1488 "wmin", 

1489 "wmin_specfun", 

1490 "wscut", 

1491 "wsfc", 

1492 "auto_projections", 

1493 "dis_froz_min", 

1494 "dis_froz_max", 

1495 "iprint", 

1496 "num_iter", 

1497 "proj", 

1498 "reduce_unk", 

1499 "scdm_entanglement", 

1500 "scdm_mu", 

1501 "scdm_proj", 

1502 "scdm_sigma", 

1503 "wannier_plot", 

1504 "wannier_plot_list", 

1505 "wannier_plot_radius", 

1506 "wannier_plot_scale", 

1507 "wannier_plot_supercell", 

1508 "wdata" 

1509 ] 

1510} 

1511 

1512ALL_KEYS = { 

1513 "pw": pw_keys, 

1514 "ph": ph_keys, 

1515 "phcg": ph_keys, 

1516 "pp": pp_keys, 

1517 "matdyn": matdyn_keys, 

1518 "dynmat": dynmat_keys, 

1519 "q2r": q2r_keys, 

1520 "dos": dos_keys, 

1521 "bands": bands_keys, 

1522 "bands_interpolation": band_interpolation_keys, 

1523 "projwfc": projwfc_keys, 

1524 "molecularpdos": molecularpdos_keys, 

1525 "importexport_binary": importexport_binary_keys, 

1526 "oscdft_pp": oscdft_pp_keys, 

1527 "kcw": kcw_keys, 

1528 "cppp": cppp_keys, 

1529 "ppacf": ppacf_keys, 

1530 "all_currents": all_currents_keys, 

1531 "turbo_lanczos": turbo_lanczos_keys, 

1532 "turbo_spectrum": turbo_spectrum_keys, 

1533 "turbo_davidson": turbo_davidson_keys, 

1534 "turbo_magnon": turbo_magnon_keys, 

1535 "turbo_eels": turbo_eels_keys, 

1536 "oscdft_et": oscdft_et_keys, 

1537 "pprism": pprism_keys, 

1538 "pwcond": pwcond_keys, 

1539 "pw2bgw": pw2bgw_keys, 

1540 "bgw2pw": bgw2pw_keys, 

1541 "hp": hp_keys, 

1542 "cp": cp_keys, 

1543 "ld1": ld1_keys, 

1544 "d3hess": d3hess_keys, 

1545 "neb": neb_keys, 

1546 "postahc": postahc_keys, 

1547 "dvscf_q2r": dvscf_q2r, 

1548 "epw": epw_keys 

1549}