Index: head/science/octopus/Makefile =================================================================== --- head/science/octopus/Makefile (revision 490765) +++ head/science/octopus/Makefile (revision 490766) @@ -1,38 +1,48 @@ # $FreeBSD$ PORTNAME= octopus DISTVERSION= 8.3 +PORTREVISION= 1 CATEGORIES= science MASTER_SITES= http://www.tddft.org/programs/${PORTNAME}/download/${DISTVERSION}/ MAINTAINER= yuri@FreeBSD.org COMMENT= Scientific program aimed at the ab initio virtual experimentation LICENSE= GPLv2 BUILD_DEPENDS= bash:shells/bash LIB_DEPENDS= libarpack.so:math/arpack-ng \ libblas.so:math/blas \ libfftw3.so:math/fftw3 \ libfontconfig.so:x11-fonts/fontconfig \ libfreetype.so:print/freetype2 \ libgd.so:graphics/gd \ libgsl.so:math/gsl \ liblapack.so:math/lapack \ libnlopt.so:math/nlopt \ libpng16.so:graphics/png \ + libsymspg.so:science/spglib \ libtiff.so:graphics/tiff \ libwebp.so:graphics/webp \ libxc.so:science/libxc USES= compiler:c++11-lang fortran gmake jpeg localbase:ldflags GNU_CONFIGURE= yes CONFIGURE_SHELL= ${PREFIX}/bin/bash USE_CXXSTD= c++11 FCFLAGS+= -I${LOCALBASE}/include -ffree-line-length-none + +OPTIONS_DEFINE= OPENMP +OPTIONS_DEFAULT= OPENMP +OPENMP_CONFIGURE_ENABLE= openmp + +post-extract: # unbundle spglib, see https://gitlab.com/octopus-code/octopus/issues/124 + @${RM} -r ${WRKSRC}/external_libs/spglib-* + @${FIND} ${WRKSRC} -name Makefile.in | ${XARGS} ${REINPLACE_CMD} 's|$$(top_builddir)/external_libs/spglib-1\.9\.9/src/libsymspg\.a|${LOCALBASE}/lib/libsymspg.so|' post-stage: # https://gitlab.com/octopus-code/octopus/issues/108 @${RM} ${STAGEDIR}${PREFIX}/include/yaml.h .include Index: head/science/octopus/pkg-plist =================================================================== --- head/science/octopus/pkg-plist (revision 490765) +++ head/science/octopus/pkg-plist (revision 490766) @@ -1,1932 +1,1912 @@ bin/oct-analyze_projections bin/oct-atomic_occupations bin/oct-casida_spectrum bin/oct-center-geom bin/oct-check_deallocs bin/oct-conductivity bin/oct-convert bin/oct-dielectric-function bin/oct-display_partitions bin/oct-floquet bin/oct-harmonic-spectrum bin/oct-help bin/oct-infrared_spectrum bin/oct-local_multipoles bin/oct-oscillator-strength bin/oct-photoelectron_spectrum bin/oct-propagation_spectrum bin/oct-run_periodic_table bin/oct-run_regression_test.pl bin/oct-run_testsuite.sh bin/oct-test bin/oct-vdW_c6 bin/oct-vibrational_spectrum bin/oct-xyz-anim bin/octopus bin/octopus_mpi include/liboct_parser.h -include/spglib/arithmetic.h -include/spglib/cell.h -include/spglib/debug.h -include/spglib/delaunay.h -include/spglib/hall_symbol.h -include/spglib/kgrid.h -include/spglib/kpoint.h -include/spglib/mathfunc.h -include/spglib/niggli.h -include/spglib/pointgroup.h -include/spglib/primitive.h -include/spglib/refinement.h -include/spglib/site_symmetry.h -include/spglib/sitesym_database.h -include/spglib/spacegroup.h -include/spglib/spg_database.h -include/spglib/spglib.h -include/spglib/spin.h -include/spglib/symmetry.h -include/spglib/version.h include/string_f.h man/man1/oct-atomic_occupations.1.gz man/man1/oct-casida_spectrum.1.gz man/man1/oct-center-geom.1.gz man/man1/oct-display_partitions.1.gz man/man1/oct-harmonic-spectrum.1.gz man/man1/oct-propagation_spectrum.1.gz man/man1/oct-run_periodic_table.1.gz man/man1/oct-run_regression_test.pl.1.gz man/man1/oct-run_testsuite.sh.1.gz man/man1/oct-vibrational_spectrum.1.gz man/man1/oct-xyz-anim.1.gz man/man1/octopus.1.gz %%DATADIR%%/doc/vars/Calculation_Modes.html %%DATADIR%%/doc/vars/Execution.html %%DATADIR%%/doc/vars/Hamiltonian.html %%DATADIR%%/doc/vars/Linear_Response.html %%DATADIR%%/doc/vars/Math.html %%DATADIR%%/doc/vars/Mesh.html %%DATADIR%%/doc/vars/Output.html %%DATADIR%%/doc/vars/SCF.html %%DATADIR%%/doc/vars/States.html %%DATADIR%%/doc/vars/System.html %%DATADIR%%/doc/vars/Time-Dependent.html %%DATADIR%%/doc/vars/Utilities.html %%DATADIR%%/doc/vars/alpha.js %%DATADIR%%/doc/vars/ftiens4.js %%DATADIR%%/doc/vars/ftv2blank.gif %%DATADIR%%/doc/vars/ftv2doc.gif %%DATADIR%%/doc/vars/ftv2folderclosed.gif %%DATADIR%%/doc/vars/ftv2folderopen.gif %%DATADIR%%/doc/vars/ftv2lastnode.gif %%DATADIR%%/doc/vars/ftv2link.gif %%DATADIR%%/doc/vars/ftv2mlastnode.gif %%DATADIR%%/doc/vars/ftv2mnode.gif %%DATADIR%%/doc/vars/ftv2node.gif %%DATADIR%%/doc/vars/ftv2plastnode.gif %%DATADIR%%/doc/vars/ftv2pnode.gif %%DATADIR%%/doc/vars/ftv2vertline.gif %%DATADIR%%/doc/vars/sections.js %%DATADIR%%/doc/vars/ua.js %%DATADIR%%/doc/vars/vars.php %%DATADIR%%/doc/vars/varsLeftFrame.php %%DATADIR%%/doc/vars/varsRightFrame.html %%DATADIR%%/doc/vars/vars_index.html %%DATADIR%%/filter_mask.data %%DATADIR%%/gdlib.png %%DATADIR%%/gequad.data %%DATADIR%%/logo %%DATADIR%%/marching_cubes_edges.data %%DATADIR%%/marching_cubes_triangles.data %%DATADIR%%/opencl/axpy.cl %%DATADIR%%/opencl/boundaries.cl %%DATADIR%%/opencl/cl_complex.h %%DATADIR%%/opencl/cl_global.h %%DATADIR%%/opencl/cl_rtype.h %%DATADIR%%/opencl/convert.cl %%DATADIR%%/opencl/copy.cl %%DATADIR%%/opencl/cuda_compat.h %%DATADIR%%/opencl/density.cl %%DATADIR%%/opencl/forces.cl %%DATADIR%%/opencl/mesh_batch.cl %%DATADIR%%/opencl/mesh_to_cube.cl %%DATADIR%%/opencl/mul.cl %%DATADIR%%/opencl/operate.cl %%DATADIR%%/opencl/pack.cl %%DATADIR%%/opencl/phase.cl %%DATADIR%%/opencl/points.cl %%DATADIR%%/opencl/projector.cl %%DATADIR%%/opencl/rotate.cl %%DATADIR%%/opencl/set_zero.cl %%DATADIR%%/opencl/subarray.cl %%DATADIR%%/opencl/trsm.cl %%DATADIR%%/opencl/vpsi.cl %%DATADIR%%/pseudopotentials/HGH/Ag.hgh %%DATADIR%%/pseudopotentials/HGH/Ag_sc.hgh %%DATADIR%%/pseudopotentials/HGH/Al.hgh %%DATADIR%%/pseudopotentials/HGH/Ar.hgh %%DATADIR%%/pseudopotentials/HGH/As.hgh %%DATADIR%%/pseudopotentials/HGH/At.hgh %%DATADIR%%/pseudopotentials/HGH/Au.hgh %%DATADIR%%/pseudopotentials/HGH/Au_sc.hgh %%DATADIR%%/pseudopotentials/HGH/B.hgh %%DATADIR%%/pseudopotentials/HGH/Ba.hgh %%DATADIR%%/pseudopotentials/HGH/Ba_sc.hgh %%DATADIR%%/pseudopotentials/HGH/Be.hgh %%DATADIR%%/pseudopotentials/HGH/Be_sc.hgh %%DATADIR%%/pseudopotentials/HGH/Bi.hgh %%DATADIR%%/pseudopotentials/HGH/Br.hgh %%DATADIR%%/pseudopotentials/HGH/C.hgh %%DATADIR%%/pseudopotentials/HGH/Ca.hgh %%DATADIR%%/pseudopotentials/HGH/Ca_sc.hgh %%DATADIR%%/pseudopotentials/HGH/Cd.hgh %%DATADIR%%/pseudopotentials/HGH/Cd_sc.hgh %%DATADIR%%/pseudopotentials/HGH/Ce_sc.hgh %%DATADIR%%/pseudopotentials/HGH/Cl.hgh %%DATADIR%%/pseudopotentials/HGH/Co.hgh %%DATADIR%%/pseudopotentials/HGH/Co_sc.hgh %%DATADIR%%/pseudopotentials/HGH/Cr.hgh %%DATADIR%%/pseudopotentials/HGH/Cr_sc.hgh %%DATADIR%%/pseudopotentials/HGH/Cs.hgh %%DATADIR%%/pseudopotentials/HGH/Cs_sc.hgh %%DATADIR%%/pseudopotentials/HGH/Cu.hgh %%DATADIR%%/pseudopotentials/HGH/Cu_sc.hgh %%DATADIR%%/pseudopotentials/HGH/Dy_sc.hgh %%DATADIR%%/pseudopotentials/HGH/Er_sc.hgh %%DATADIR%%/pseudopotentials/HGH/Eu_sc.hgh %%DATADIR%%/pseudopotentials/HGH/F.hgh %%DATADIR%%/pseudopotentials/HGH/Fe.hgh %%DATADIR%%/pseudopotentials/HGH/Fe_sc.hgh %%DATADIR%%/pseudopotentials/HGH/Ga.hgh %%DATADIR%%/pseudopotentials/HGH/Ga_sc.hgh %%DATADIR%%/pseudopotentials/HGH/Gd_sc.hgh %%DATADIR%%/pseudopotentials/HGH/Ge.hgh %%DATADIR%%/pseudopotentials/HGH/H.hgh %%DATADIR%%/pseudopotentials/HGH/He.hgh %%DATADIR%%/pseudopotentials/HGH/Hf_sc.hgh %%DATADIR%%/pseudopotentials/HGH/Hg.hgh %%DATADIR%%/pseudopotentials/HGH/Hg_sc.hgh %%DATADIR%%/pseudopotentials/HGH/Ho_sc.hgh %%DATADIR%%/pseudopotentials/HGH/I.hgh %%DATADIR%%/pseudopotentials/HGH/In.hgh %%DATADIR%%/pseudopotentials/HGH/In_sc.hgh %%DATADIR%%/pseudopotentials/HGH/Ir.hgh %%DATADIR%%/pseudopotentials/HGH/Ir_sc.hgh %%DATADIR%%/pseudopotentials/HGH/K.hgh %%DATADIR%%/pseudopotentials/HGH/K_sc.hgh %%DATADIR%%/pseudopotentials/HGH/Kr.hgh %%DATADIR%%/pseudopotentials/HGH/La_sc.hgh %%DATADIR%%/pseudopotentials/HGH/Li.hgh %%DATADIR%%/pseudopotentials/HGH/Li_sc.hgh %%DATADIR%%/pseudopotentials/HGH/Lu_sc.hgh %%DATADIR%%/pseudopotentials/HGH/Mg.hgh %%DATADIR%%/pseudopotentials/HGH/Mg_sc.hgh %%DATADIR%%/pseudopotentials/HGH/Mn.hgh %%DATADIR%%/pseudopotentials/HGH/Mn_sc.hgh %%DATADIR%%/pseudopotentials/HGH/Mo.hgh %%DATADIR%%/pseudopotentials/HGH/Mo_sc.hgh %%DATADIR%%/pseudopotentials/HGH/N.hgh %%DATADIR%%/pseudopotentials/HGH/Na.hgh %%DATADIR%%/pseudopotentials/HGH/Na_sc.hgh %%DATADIR%%/pseudopotentials/HGH/Nb.hgh %%DATADIR%%/pseudopotentials/HGH/Nb_sc.hgh %%DATADIR%%/pseudopotentials/HGH/Nd_sc.hgh %%DATADIR%%/pseudopotentials/HGH/Ne.hgh %%DATADIR%%/pseudopotentials/HGH/Ni.hgh %%DATADIR%%/pseudopotentials/HGH/Ni_sc.hgh %%DATADIR%%/pseudopotentials/HGH/O.hgh %%DATADIR%%/pseudopotentials/HGH/Os.hgh %%DATADIR%%/pseudopotentials/HGH/Os_sc.hgh %%DATADIR%%/pseudopotentials/HGH/P.hgh %%DATADIR%%/pseudopotentials/HGH/Pb.hgh %%DATADIR%%/pseudopotentials/HGH/Pd.hgh %%DATADIR%%/pseudopotentials/HGH/Pd_sc.hgh %%DATADIR%%/pseudopotentials/HGH/Pm_sc.hgh %%DATADIR%%/pseudopotentials/HGH/Po.hgh %%DATADIR%%/pseudopotentials/HGH/Pr_sc.hgh %%DATADIR%%/pseudopotentials/HGH/Pt.hgh %%DATADIR%%/pseudopotentials/HGH/Pt_sc.hgh %%DATADIR%%/pseudopotentials/HGH/Rb.hgh %%DATADIR%%/pseudopotentials/HGH/Rb_sc.hgh %%DATADIR%%/pseudopotentials/HGH/Re.hgh %%DATADIR%%/pseudopotentials/HGH/Re_sc.hgh %%DATADIR%%/pseudopotentials/HGH/Rh.hgh %%DATADIR%%/pseudopotentials/HGH/Rh_sc.hgh %%DATADIR%%/pseudopotentials/HGH/Rn.hgh %%DATADIR%%/pseudopotentials/HGH/Ru.hgh %%DATADIR%%/pseudopotentials/HGH/Ru_sc.hgh %%DATADIR%%/pseudopotentials/HGH/S.hgh %%DATADIR%%/pseudopotentials/HGH/Sb.hgh %%DATADIR%%/pseudopotentials/HGH/Sc.hgh %%DATADIR%%/pseudopotentials/HGH/Sc_sc.hgh %%DATADIR%%/pseudopotentials/HGH/Se.hgh %%DATADIR%%/pseudopotentials/HGH/Si.hgh %%DATADIR%%/pseudopotentials/HGH/Sm_sc.hgh %%DATADIR%%/pseudopotentials/HGH/Sn.hgh %%DATADIR%%/pseudopotentials/HGH/Sr.hgh %%DATADIR%%/pseudopotentials/HGH/Sr_sc.hgh %%DATADIR%%/pseudopotentials/HGH/Ta.hgh %%DATADIR%%/pseudopotentials/HGH/Ta_sc.hgh %%DATADIR%%/pseudopotentials/HGH/Tb_sc.hgh %%DATADIR%%/pseudopotentials/HGH/Tc.hgh %%DATADIR%%/pseudopotentials/HGH/Tc_sc.hgh %%DATADIR%%/pseudopotentials/HGH/Te.hgh %%DATADIR%%/pseudopotentials/HGH/Ti.hgh %%DATADIR%%/pseudopotentials/HGH/Ti_sc.hgh %%DATADIR%%/pseudopotentials/HGH/Tl.hgh %%DATADIR%%/pseudopotentials/HGH/Tl_sc.hgh %%DATADIR%%/pseudopotentials/HGH/Tm_sc.hgh %%DATADIR%%/pseudopotentials/HGH/V.hgh %%DATADIR%%/pseudopotentials/HGH/V_sc.hgh %%DATADIR%%/pseudopotentials/HGH/W.hgh %%DATADIR%%/pseudopotentials/HGH/W_sc.hgh %%DATADIR%%/pseudopotentials/HGH/Xe.hgh %%DATADIR%%/pseudopotentials/HGH/Y.hgh %%DATADIR%%/pseudopotentials/HGH/Y_sc.hgh %%DATADIR%%/pseudopotentials/HGH/Yb_sc.hgh %%DATADIR%%/pseudopotentials/HGH/Zn.hgh %%DATADIR%%/pseudopotentials/HGH/Zn_sc.hgh %%DATADIR%%/pseudopotentials/HGH/Zr.hgh %%DATADIR%%/pseudopotentials/HGH/Zr_sc.hgh %%DATADIR%%/pseudopotentials/HGH/configurations %%DATADIR%%/pseudopotentials/PSF/C.psf %%DATADIR%%/pseudopotentials/PSF/Cd.psf %%DATADIR%%/pseudopotentials/PSF/H.psf %%DATADIR%%/pseudopotentials/PSF/Li.psf %%DATADIR%%/pseudopotentials/PSF/N.psf %%DATADIR%%/pseudopotentials/PSF/Na.psf %%DATADIR%%/pseudopotentials/PSF/O.psf %%DATADIR%%/pseudopotentials/PSF/S.psf %%DATADIR%%/pseudopotentials/PSF/Se.psf %%DATADIR%%/pseudopotentials/PSF/Si.psf %%DATADIR%%/pseudopotentials/PSF/Ti.psf %%DATADIR%%/pseudopotentials/elements.dat %%DATADIR%%/pseudopotentials/hgh_lda.set %%DATADIR%%/pseudopotentials/hscv_lda.set %%DATADIR%%/pseudopotentials/hscv_pbe.set %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/Ag.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/Al.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/Ar.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/As.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/Au.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/B.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/Ba.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/Be.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/Bi.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/Br.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/C.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/Ca.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/Cd.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/Cl.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/Co.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/Cr.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/Cs.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/Cu.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/F.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/Fe.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/Ga.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/Ge.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/H.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/He.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/Hf.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/Hg.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/I.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/In.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/Ir.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/K.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/Kr.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/La.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/Li.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/Lu.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/Mg.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/Mn.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/Mo.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/N.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/Na.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/Nb.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/Ne.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/Ni.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/O.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/Os.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/P.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/Pb.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/Pd.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/Po.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/Pt.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/Rb.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/Re.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/Rh.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/Rn.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/Ru.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/S.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/Sb.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/Sc.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/Se.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/Si.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/Sn.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/Sr.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/Ta.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/Tc.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/Te.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/Ti.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/Tl.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/V.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/W.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/Xe.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/Y.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/Zn.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_standard/Zr.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/Ag.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/Al.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/Ar.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/As.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/Au.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/B.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/Ba.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/Be.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/Bi.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/Br.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/C.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/Ca.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/Cd.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/Cl.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/Co.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/Cr.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/Cs.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/Cu.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/F.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/Fe.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/Ga.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/Ge.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/H.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/He.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/Hf.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/Hg.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/I.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/In.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/Ir.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/K.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/Kr.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/La.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/Li.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/Lu.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/Mg.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/Mn.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/Mo.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/N.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/Na.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/Nb.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/Ne.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/Ni.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/O.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/Os.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/P.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/Pb.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/Pd.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/Po.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/Pt.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/Rb.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/Re.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/Rh.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/Rn.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/Ru.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/S.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/Sb.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/Sc.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/Se.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/Si.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/Sn.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/Sr.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/Ta.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/Tc.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/Te.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/Ti.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/Tl.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/V.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/W.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/Xe.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/Y.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/Zn.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbe_stringent/Zr.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/Ag.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/Al.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/Ar.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/As.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/Au.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/B.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/Ba.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/Be.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/Bi.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/Br.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/C.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/Ca.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/Cd.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/Cl.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/Co.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/Cr.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/Cs.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/Cu.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/F.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/Fe.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/Ga.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/Ge.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/H.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/He.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/Hf.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/Hg.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/I.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/In.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/Ir.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/K.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/Kr.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/La.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/Li.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/Lu.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/Mg.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/Mn.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/Mo.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/N.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/Na.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/Nb.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/Ne.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/Ni.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/O.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/Os.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/P.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/Pb.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/Pd.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/Po.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/Pt.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/Rb.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/Re.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/Rh.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/Rn.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/Ru.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/S.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/Sb.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/Sc.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/Se.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/Si.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/Sn.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/Sr.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/Ta.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/Tc.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/Te.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/Ti.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/Tl.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/V.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/W.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/Xe.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/Y.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/Zn.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_standard/Zr.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/Ag.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/Al.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/Ar.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/As.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/Au.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/B.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/Ba.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/Be.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/Bi.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/Br.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/C.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/Ca.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/Cd.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/Cl.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/Co.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/Cr.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/Cs.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/Cu.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/F.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/Fe.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/Ga.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/Ge.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/H.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/He.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/Hf.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/Hg.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/I.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/In.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/Ir.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/K.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/Kr.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/La.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/Li.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/Lu.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/Mg.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/Mn.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/Mo.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/N.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/Na.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/Nb.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/Ne.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/Ni.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/O.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/Os.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/P.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/Pb.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/Pd.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/Po.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/Pt.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/Rb.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/Re.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/Rh.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/Rn.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/Ru.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/S.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/Sb.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/Sc.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/Se.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/Si.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/Sn.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/Sr.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/Ta.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/Tc.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/Te.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/Ti.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/Tl.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/V.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/W.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/Xe.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/Y.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/Zn.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pbesol_stringent/Zr.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/Ag.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/Al.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/Ar.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/As.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/Au.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/B.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/Ba.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/Be.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/Bi.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/Br.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/C.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/Ca.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/Cd.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/Cl.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/Cr.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/Cu.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/F.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/Fe.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/Ga.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/H.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/He.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/Hf.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/Hg.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/I.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/In.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/Ir.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/K.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/Kr.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/Li.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/Mg.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/Mo.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/N.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/Na.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/Nb.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/Ne.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/Os.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/P.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/Pb.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/Pd.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/Po.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/Pt.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/Rb.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/Re.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/Rh.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/Rn.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/Ru.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/S.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/Sb.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/Sc.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/Se.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/Si.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/Sn.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/Sr.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/Ta.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/Tc.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/Te.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/Ti.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/Tl.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/V.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/W.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/Xe.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/Y.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/Zn.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_standard/Zr.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/Ag.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/Al.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/Ar.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/As.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/Au.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/B.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/Ba.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/Be.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/Bi.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/C.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/Ca.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/Cd.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/Cl.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/Cr.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/Cu.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/F.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/Fe.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/Ga.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/H.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/He.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/Hf.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/Hg.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/In.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/Ir.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/K.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/Kr.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/Li.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/Mg.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/Mo.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/N.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/Na.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/Nb.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/Ne.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/Os.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/P.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/Pb.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/Pd.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/Po.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/Pt.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/Rb.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/Re.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/Rh.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/Rn.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/Ru.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/S.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/Sb.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/Sc.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/Se.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/Si.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/Sn.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/Sr.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/Ta.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/Tc.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/Te.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/Ti.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/Tl.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/V.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/W.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/Xe.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/Y.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/Zn.upf %%DATADIR%%/pseudopotentials/pseudo-dojo.org/nc-sr-04_pw_stringent/Zr.upf %%DATADIR%%/pseudopotentials/pseudodojo_lda.set %%DATADIR%%/pseudopotentials/pseudodojo_lda_stringent.set %%DATADIR%%/pseudopotentials/pseudodojo_pbe.set %%DATADIR%%/pseudopotentials/pseudodojo_pbe_stringent.set %%DATADIR%%/pseudopotentials/pseudodojo_pbesol.set %%DATADIR%%/pseudopotentials/pseudodojo_pbesol_stringent.set %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Ac_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Ag_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Al_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Ar_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/As_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/At_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Au_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/B_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Ba_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Bi_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Br_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/C_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Ca_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Cd_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Ce_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Cl_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Co_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Cr_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Cs_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Cu_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Dy_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Er_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Eu_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/F_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Fe_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Fr_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Ga_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Gd_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Ge_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/H_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/He_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Hf_HSCV_LDA-1.1.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Hg_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Ho_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/I_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/In_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Ir_HSCV_LDA-1.1.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/K_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Kr_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/La_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Li_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Lu_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Mg_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Mn_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Mo_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/N_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Na_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Nb_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Nd_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Ne_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Ni_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Np_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/O_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Os_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/P_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Pa_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Pb_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Pd_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Pm_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Po_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Pr_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Pt_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Pu_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Ra_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Rb_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Re_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Rh_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Rn_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Ru_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/S_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Sb_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Sc_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Se_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Si_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Sm_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Sn_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Sr_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Ta_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Tb_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Tc_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Te_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Th_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Ti_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Tl_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Tm_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/U_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/V_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/W_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Xe_HSCV_LDA-1.2.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Y_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Yb_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Zn_HSCV_LDA-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/lda/Zr_HSCV_LDA-1.1.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Ac_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Ag_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Al_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Ar_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/As_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/At_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Au_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/B_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Ba_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Bi_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Br_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/C_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Ca_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Cd_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Ce_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Cl_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Co_HSCV_PBE-1.1.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Cr_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Cs_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Cu_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/D_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Dy_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Er_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Eu_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/F_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Fe_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Fr_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Ga_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Gd_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Ge_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/H_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/He_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Hf_HSCV_PBE-1.1.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Hg_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Ho_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/I_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/In_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Ir_HSCV_PBE-1.1.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/K_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Kr_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/La_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Li_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Lu_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Mg_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Mn_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Mo_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/N_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Na_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Nb_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Nd_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Ne_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Ni_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Np_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/O_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Os_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/P_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Pa_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Pb_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Pd_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Pm_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Po_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Pr_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Pt_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Pu_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Ra_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Rb_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Re_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Rh_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Rn_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Ru_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/S_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Sb_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Sc_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Se_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Si_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Sm_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Sn_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Sr_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Ta_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Tb_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Tc_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Te_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Th_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Ti_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Tl_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Tm_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/U_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/V_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/W_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Xe_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Y_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Yb_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Zn_HSCV_PBE-1.0.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/hscv/pbe/Zr_HSCV_PBE-1.1.xml %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/Ag_ONCV_PBE-1.0.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/Al_ONCV_PBE-1.0.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/Ar_ONCV_PBE-1.1.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/As_ONCV_PBE-1.1.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/Au_ONCV_PBE-1.0.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/B_ONCV_PBE-1.0.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/Ba_ONCV_PBE-1.0.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/Be_ONCV_PBE-1.0.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/Bi_ONCV_PBE-1.0.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/Br_ONCV_PBE-1.0.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/COPYING %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/C_ONCV_PBE-1.0.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/Ca_ONCV_PBE-1.0.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/Cd_ONCV_PBE-1.0.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/Cl_ONCV_PBE-1.1.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/Co_ONCV_PBE-1.0.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/Cr_ONCV_PBE-1.0.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/Cs_ONCV_PBE-1.1.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/Cu_ONCV_PBE-1.0.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/F_ONCV_PBE-1.0.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/Fe_ONCV_PBE-1.0.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/Ga_ONCV_PBE-1.0.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/Ge_ONCV_PBE-1.0.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/H_ONCV_PBE-1.0.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/He_ONCV_PBE-1.0.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/Hf_ONCV_PBE-1.0.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/Hg_ONCV_PBE-1.0.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/I_ONCV_PBE-1.1.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/In_ONCV_PBE-1.1.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/Ir_ONCV_PBE-1.0.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/K_ONCV_PBE-1.0.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/Kr_ONCV_PBE-1.0.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/La_ONCV_PBE-1.0.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/Li_ONCV_PBE-1.0.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/Mg_ONCV_PBE-1.0.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/Mn_ONCV_PBE-1.0.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/Mo_ONCV_PBE-1.0.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/N_ONCV_PBE-1.0.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/Na_ONCV_PBE-1.0.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/Nb_ONCV_PBE-1.0.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/Ne_ONCV_PBE-1.0.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/Ni_ONCV_PBE-1.0.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/O_ONCV_PBE-1.0.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/Os_ONCV_PBE-1.0.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/P_ONCV_PBE-1.1.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/Pb_ONCV_PBE-1.0.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/Pd_ONCV_PBE-1.0.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/Pt_ONCV_PBE-1.0.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/README.Octopus %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/Rb_ONCV_PBE-1.0.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/Re_ONCV_PBE-1.0.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/Rh_ONCV_PBE-1.0.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/Ru_ONCV_PBE-1.0.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/S_ONCV_PBE-1.1.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/Sb_ONCV_PBE-1.1.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/Sc_ONCV_PBE-1.0.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/Se_ONCV_PBE-1.1.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/Si_ONCV_PBE-1.1.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/Sn_ONCV_PBE-1.1.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/Sr_ONCV_PBE-1.0.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/Ta_ONCV_PBE-1.0.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/Tc_ONCV_PBE-1.0.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/Te_ONCV_PBE-1.1.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/Ti_ONCV_PBE-1.0.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/Tl_ONCV_PBE-1.0.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/V_ONCV_PBE-1.0.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/W_ONCV_PBE-1.0.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/Xe_ONCV_PBE-1.1.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/Y_ONCV_PBE-1.0.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/Zn_ONCV_PBE-1.0.upf %%DATADIR%%/pseudopotentials/quantum-simulation.org/sg15/Zr_ONCV_PBE-1.0.upf %%DATADIR%%/pseudopotentials/sg15.set %%DATADIR%%/pseudopotentials/standard.set %%DATADIR%%/quadrature/README %%DATADIR%%/quadrature/lebedev_003.txt %%DATADIR%%/quadrature/lebedev_005.txt %%DATADIR%%/quadrature/lebedev_007.txt %%DATADIR%%/quadrature/lebedev_009.txt %%DATADIR%%/quadrature/lebedev_011.txt %%DATADIR%%/quadrature/lebedev_013.txt %%DATADIR%%/quadrature/lebedev_015.txt %%DATADIR%%/quadrature/lebedev_017.txt %%DATADIR%%/quadrature/lebedev_019.txt %%DATADIR%%/quadrature/lebedev_021.txt %%DATADIR%%/quadrature/lebedev_023.txt %%DATADIR%%/quadrature/lebedev_025.txt %%DATADIR%%/quadrature/lebedev_027.txt %%DATADIR%%/quadrature/lebedev_029.txt %%DATADIR%%/quadrature/lebedev_031.txt %%DATADIR%%/quadrature/lebedev_035.txt %%DATADIR%%/quadrature/lebedev_041.txt %%DATADIR%%/quadrature/lebedev_047.txt %%DATADIR%%/quadrature/lebedev_053.txt %%DATADIR%%/quadrature/lebedev_059.txt %%DATADIR%%/quadrature/lebedev_065.txt %%DATADIR%%/quadrature/lebedev_071.txt %%DATADIR%%/quadrature/lebedev_077.txt %%DATADIR%%/quadrature/lebedev_083.txt %%DATADIR%%/quadrature/lebedev_089.txt %%DATADIR%%/quadrature/lebedev_095.txt %%DATADIR%%/quadrature/lebedev_101.txt %%DATADIR%%/quadrature/lebedev_107.txt %%DATADIR%%/quadrature/lebedev_113.txt %%DATADIR%%/quadrature/lebedev_119.txt %%DATADIR%%/quadrature/lebedev_125.txt %%DATADIR%%/quadrature/lebedev_131.txt %%DATADIR%%/recipes/da/octopus_gallega.txt %%DATADIR%%/recipes/da/sugo_zucchini.txt %%DATADIR%%/recipes/de/oktopus_gallega.txt %%DATADIR%%/recipes/disclaimer.txt %%DATADIR%%/recipes/en/cheese_spaetzle.txt %%DATADIR%%/recipes/en/octopus_gallega.txt %%DATADIR%%/recipes/en/pork_honey.txt %%DATADIR%%/recipes/en/sugo_zucchini.txt %%DATADIR%%/recipes/es/pulpo_a_feira.txt %%DATADIR%%/recipes/es/pulpo_asado.txt %%DATADIR%%/recipes/eu/txipiroiak_bere_tintan.txt %%DATADIR%%/recipes/it/polpo_galiziana.txt %%DATADIR%%/testsuite/complex_scaling/01-harmonic-oscillator.01-independent.inp %%DATADIR%%/testsuite/complex_scaling/01-harmonic-oscillator.02-complex_lda.inp %%DATADIR%%/testsuite/complex_scaling/01-harmonic-oscillator.test %%DATADIR%%/testsuite/complex_scaling/02-1dwell.01-lda.inp %%DATADIR%%/testsuite/complex_scaling/02-1dwell.test %%DATADIR%%/testsuite/complex_scaling/03-stark.01-1d.inp %%DATADIR%%/testsuite/complex_scaling/03-stark.test %%DATADIR%%/testsuite/components/01-derivatives_1d.01.inp %%DATADIR%%/testsuite/components/01-derivatives_1d.02-fortran.inp %%DATADIR%%/testsuite/components/01-derivatives_1d.test %%DATADIR%%/testsuite/components/02-derivatives_2d.01.inp %%DATADIR%%/testsuite/components/02-derivatives_2d.test %%DATADIR%%/testsuite/components/03-derivatives_3d.01.inp %%DATADIR%%/testsuite/components/03-derivatives_3d.test %%DATADIR%%/testsuite/components/04-hartree_3d_cg.01-cg_corrected.inp %%DATADIR%%/testsuite/components/04-hartree_3d_cg.test %%DATADIR%%/testsuite/components/05-hartree_3d_fft.01-fft.inp %%DATADIR%%/testsuite/components/05-hartree_3d_fft.02-fft_corrected.inp %%DATADIR%%/testsuite/components/05-hartree_3d_fft.test %%DATADIR%%/testsuite/components/06-hartree_3d_isf.01-isf.inp %%DATADIR%%/testsuite/components/06-hartree_3d_isf.test %%DATADIR%%/testsuite/components/07-cholesky_serial.01-real.inp %%DATADIR%%/testsuite/components/07-cholesky_serial.02-complex.inp %%DATADIR%%/testsuite/components/07-cholesky_serial.03-parindep.inp %%DATADIR%%/testsuite/components/07-cholesky_serial.test %%DATADIR%%/testsuite/components/08-mgs.01-real.inp %%DATADIR%%/testsuite/components/08-mgs.02-complex.inp %%DATADIR%%/testsuite/components/08-mgs.test %%DATADIR%%/testsuite/components/10-hartree_pfft.01-fft.inp %%DATADIR%%/testsuite/components/10-hartree_pfft.02-fft_corrected.inp %%DATADIR%%/testsuite/components/10-hartree_pfft.test %%DATADIR%%/testsuite/components/11-hartree_cl.01-fft.inp %%DATADIR%%/testsuite/components/11-hartree_cl.test %%DATADIR%%/testsuite/components/12-hartree_direct_3d.01.inp %%DATADIR%%/testsuite/components/12-hartree_direct_3d.test %%DATADIR%%/testsuite/components/13-hartree_3d_mg.01-multigrid.inp %%DATADIR%%/testsuite/components/13-hartree_3d_mg.test %%DATADIR%%/testsuite/components/14-center-geom.01-run.inp %%DATADIR%%/testsuite/components/14-center-geom.test %%DATADIR%%/testsuite/components/15-cholesky_parallel.01-real.inp %%DATADIR%%/testsuite/components/15-cholesky_parallel.02-complex.inp %%DATADIR%%/testsuite/components/15-cholesky_parallel.test %%DATADIR%%/testsuite/components/16-hartree_3d_libisf.01-libisf.inp %%DATADIR%%/testsuite/components/16-hartree_3d_libisf.02-libisf.inp %%DATADIR%%/testsuite/components/16-hartree_3d_libisf.test %%DATADIR%%/testsuite/components/17-recipe.inp %%DATADIR%%/testsuite/components/17-recipe.test %%DATADIR%%/testsuite/components/18-interpolation.01-1d.inp %%DATADIR%%/testsuite/components/18-interpolation.02-2d.inp %%DATADIR%%/testsuite/components/18-interpolation.03-3d.inp %%DATADIR%%/testsuite/components/18-interpolation.test %%DATADIR%%/testsuite/components/19-hgh_soc.01-3d.inp %%DATADIR%%/testsuite/components/19-hgh_soc.test %%DATADIR%%/testsuite/finite_systems_1d/01-hydrogen.01-ground_state.inp %%DATADIR%%/testsuite/finite_systems_1d/01-hydrogen.02-excited_state.inp %%DATADIR%%/testsuite/finite_systems_1d/01-hydrogen.03-dummy.inp %%DATADIR%%/testsuite/finite_systems_1d/01-hydrogen.test %%DATADIR%%/testsuite/finite_systems_1d/02-neon_mpi.01-ground_state-IP_par_domains.inp %%DATADIR%%/testsuite/finite_systems_1d/02-neon_mpi.02-ground_state-kli_par_domains.inp %%DATADIR%%/testsuite/finite_systems_1d/02-neon_mpi.03-td_calc-kli_par_states.inp %%DATADIR%%/testsuite/finite_systems_1d/02-neon_mpi.test %%DATADIR%%/testsuite/finite_systems_1d/09-morse.01-gs.inp %%DATADIR%%/testsuite/finite_systems_1d/09-morse.02-unocc.inp %%DATADIR%%/testsuite/finite_systems_1d/09-morse.03-td.inp %%DATADIR%%/testsuite/finite_systems_1d/09-morse.test %%DATADIR%%/testsuite/finite_systems_2d/01-quadratic_box.01-ground_state.inp %%DATADIR%%/testsuite/finite_systems_2d/01-quadratic_box.02-hartree.inp %%DATADIR%%/testsuite/finite_systems_2d/01-quadratic_box.03-hartree+xc.inp %%DATADIR%%/testsuite/finite_systems_2d/01-quadratic_box.04-spin_polarized.inp %%DATADIR%%/testsuite/finite_systems_2d/01-quadratic_box.test %%DATADIR%%/testsuite/finite_systems_2d/02-fock-darwin.01-ground_state.inp %%DATADIR%%/testsuite/finite_systems_2d/02-fock-darwin.02-ground_state.inp %%DATADIR%%/testsuite/finite_systems_2d/02-fock-darwin.03-ground_state.inp %%DATADIR%%/testsuite/finite_systems_2d/02-fock-darwin.04-ground_state.inp %%DATADIR%%/testsuite/finite_systems_2d/02-fock-darwin.test %%DATADIR%%/testsuite/finite_systems_2d/03-helium_atom.01-ground_state.inp %%DATADIR%%/testsuite/finite_systems_2d/03-helium_atom.02-ground_state.inp %%DATADIR%%/testsuite/finite_systems_2d/03-helium_atom.test %%DATADIR%%/testsuite/finite_systems_2d/04-biot_savart.01-gs.inp %%DATADIR%%/testsuite/finite_systems_2d/04-biot_savart.test %%DATADIR%%/testsuite/finite_systems_2d/05-spin_precession.01-ground_state.inp %%DATADIR%%/testsuite/finite_systems_2d/05-spin_precession.02-time_propagation.inp %%DATADIR%%/testsuite/finite_systems_2d/05-spin_precession.test %%DATADIR%%/testsuite/finite_systems_2d/07-modelmb.01-gs.inp %%DATADIR%%/testsuite/finite_systems_2d/07-modelmb.02-td.inp %%DATADIR%%/testsuite/finite_systems_2d/07-modelmb.test %%DATADIR%%/testsuite/finite_systems_2d/08-gdlib.01-gs.inp %%DATADIR%%/testsuite/finite_systems_2d/08-gdlib.test %%DATADIR%%/testsuite/finite_systems_3d/01-carbon_atom.01-psf_l0.inp %%DATADIR%%/testsuite/finite_systems_3d/01-carbon_atom.02-psf_l1.inp %%DATADIR%%/testsuite/finite_systems_3d/01-carbon_atom.03-ground_state_double_grid.inp %%DATADIR%%/testsuite/finite_systems_3d/01-carbon_atom.test %%DATADIR%%/testsuite/finite_systems_3d/02-curvilinear_coordinates.01-gygi.inp %%DATADIR%%/testsuite/finite_systems_3d/02-curvilinear_coordinates.test %%DATADIR%%/testsuite/finite_systems_3d/03-magnetic.01-gs-unpolarized.inp %%DATADIR%%/testsuite/finite_systems_3d/03-magnetic.02-td-unpolarized.inp %%DATADIR%%/testsuite/finite_systems_3d/03-magnetic.03-gs-polarized.inp %%DATADIR%%/testsuite/finite_systems_3d/03-magnetic.04-td-polarized.inp %%DATADIR%%/testsuite/finite_systems_3d/03-magnetic.05-gs-spinors.inp %%DATADIR%%/testsuite/finite_systems_3d/03-magnetic.06-td-spinors.inp %%DATADIR%%/testsuite/finite_systems_3d/03-magnetic.test %%DATADIR%%/testsuite/finite_systems_3d/04-jellium.01-ground_state.inp %%DATADIR%%/testsuite/finite_systems_3d/04-jellium.test %%DATADIR%%/testsuite/finite_systems_3d/05-output.01-gs.inp %%DATADIR%%/testsuite/finite_systems_3d/05-output.02-convert.inp %%DATADIR%%/testsuite/finite_systems_3d/05-output.03-convert-op.inp %%DATADIR%%/testsuite/finite_systems_3d/05-output.test %%DATADIR%%/testsuite/finite_systems_3d/06-restart.01-gs_mixrho.inp %%DATADIR%%/testsuite/finite_systems_3d/06-restart.02-restart_gs_mixrho.inp %%DATADIR%%/testsuite/finite_systems_3d/06-restart.03-gs_mixvhxc.inp %%DATADIR%%/testsuite/finite_systems_3d/06-restart.04-restart_gs_mixvhxc.inp %%DATADIR%%/testsuite/finite_systems_3d/06-restart.05-restart_gs.inp %%DATADIR%%/testsuite/finite_systems_3d/06-restart.06-td_calc.inp %%DATADIR%%/testsuite/finite_systems_3d/06-restart.07-restart_td_calc.inp %%DATADIR%%/testsuite/finite_systems_3d/06-restart.test %%DATADIR%%/testsuite/finite_systems_3d/07-spin_orbit_coupling.01-hgh.inp %%DATADIR%%/testsuite/finite_systems_3d/07-spin_orbit_coupling.02-rkb.inp %%DATADIR%%/testsuite/finite_systems_3d/07-spin_orbit_coupling.02-xe-pseudo.upf %%DATADIR%%/testsuite/finite_systems_3d/07-spin_orbit_coupling.test %%DATADIR%%/testsuite/finite_systems_3d/08-spin_orbit_coupling_full.01-hgh.inp %%DATADIR%%/testsuite/finite_systems_3d/08-spin_orbit_coupling_full.02-rkb.inp %%DATADIR%%/testsuite/finite_systems_3d/08-spin_orbit_coupling_full.03-unocc.inp %%DATADIR%%/testsuite/finite_systems_3d/08-spin_orbit_coupling_full.Xe.UPF %%DATADIR%%/testsuite/finite_systems_3d/08-spin_orbit_coupling_full.test %%DATADIR%%/testsuite/finite_systems_3d/09-spinors.01-ground_state.inp %%DATADIR%%/testsuite/finite_systems_3d/09-spinors.02-rmmdiis.inp %%DATADIR%%/testsuite/finite_systems_3d/09-spinors.03-rmmdiis_extra_states.inp %%DATADIR%%/testsuite/finite_systems_3d/09-spinors.test %%DATADIR%%/testsuite/finite_systems_3d/10-fullerene.01-gs.inp %%DATADIR%%/testsuite/finite_systems_3d/10-fullerene.geometry.xyz %%DATADIR%%/testsuite/finite_systems_3d/10-fullerene.test %%DATADIR%%/testsuite/finite_systems_3d/12-forces.01-N2_gs.inp %%DATADIR%%/testsuite/finite_systems_3d/12-forces.02-N2_gs.inp %%DATADIR%%/testsuite/finite_systems_3d/12-forces.03-N2_gs.inp %%DATADIR%%/testsuite/finite_systems_3d/12-forces.test %%DATADIR%%/testsuite/finite_systems_3d/13-full_potential_hydrogen.01-gs.inp %%DATADIR%%/testsuite/finite_systems_3d/13-full_potential_hydrogen.02-gs-cg.inp %%DATADIR%%/testsuite/finite_systems_3d/13-full_potential_hydrogen.test %%DATADIR%%/testsuite/finite_systems_3d/14-fullerene_packed.01-gs.inp %%DATADIR%%/testsuite/finite_systems_3d/14-fullerene_packed.test %%DATADIR%%/testsuite/finite_systems_3d/15-fullerene_stdlcao.01-gs.inp %%DATADIR%%/testsuite/finite_systems_3d/15-fullerene_stdlcao.test %%DATADIR%%/testsuite/finite_systems_3d/16-scfinlcao_std.01-gs.inp %%DATADIR%%/testsuite/finite_systems_3d/16-scfinlcao_std.Cl.psf %%DATADIR%%/testsuite/finite_systems_3d/16-scfinlcao_std.test %%DATADIR%%/testsuite/finite_systems_3d/17-scfinlcao_alt.01-gs.inp %%DATADIR%%/testsuite/finite_systems_3d/17-scfinlcao_alt.Cl.psf %%DATADIR%%/testsuite/finite_systems_3d/17-scfinlcao_alt.test %%DATADIR%%/testsuite/finite_systems_3d/20-eigensolver.01-lobpcg.inp %%DATADIR%%/testsuite/finite_systems_3d/20-eigensolver.02-cg.inp %%DATADIR%%/testsuite/finite_systems_3d/20-eigensolver.03-cg_new.inp %%DATADIR%%/testsuite/finite_systems_3d/20-eigensolver.04-plan.inp %%DATADIR%%/testsuite/finite_systems_3d/20-eigensolver.05-evolution.inp %%DATADIR%%/testsuite/finite_systems_3d/20-eigensolver.06-rmmdiis.inp %%DATADIR%%/testsuite/finite_systems_3d/20-eigensolver.07-psd.inp %%DATADIR%%/testsuite/finite_systems_3d/20-eigensolver.test %%DATADIR%%/testsuite/finite_systems_3d/21-lobpcg.01-spin_polarized.inp %%DATADIR%%/testsuite/finite_systems_3d/21-lobpcg.02-spinors.inp %%DATADIR%%/testsuite/finite_systems_3d/21-lobpcg.test %%DATADIR%%/testsuite/finite_systems_3d/23-go-na2.01-steep.inp %%DATADIR%%/testsuite/finite_systems_3d/23-go-na2.02-simplex.inp %%DATADIR%%/testsuite/finite_systems_3d/23-go-na2.03-fire.inp %%DATADIR%%/testsuite/finite_systems_3d/23-go-na2.04-fire_restart.inp %%DATADIR%%/testsuite/finite_systems_3d/23-go-na2.05-constrains.inp %%DATADIR%%/testsuite/finite_systems_3d/23-go-na2.test %%DATADIR%%/testsuite/finite_systems_3d/24-o2-spin.01-gs.inp %%DATADIR%%/testsuite/finite_systems_3d/24-o2-spin.test %%DATADIR%%/testsuite/finite_systems_3d/25-multiresolution.01-Hatom.inp %%DATADIR%%/testsuite/finite_systems_3d/25-multiresolution.test %%DATADIR%%/testsuite/finite_systems_3d/27-fine_mesh.01-gs.inp %%DATADIR%%/testsuite/finite_systems_3d/27-fine_mesh.test %%DATADIR%%/testsuite/finite_systems_3d/29-pcm_chlorine_anion.01-ground_state.inp %%DATADIR%%/testsuite/finite_systems_3d/29-pcm_chlorine_anion.02-td_prop.inp %%DATADIR%%/testsuite/finite_systems_3d/29-pcm_chlorine_anion.test %%DATADIR%%/testsuite/finite_systems_3d/30-local_multipoles.01-gs.inp %%DATADIR%%/testsuite/finite_systems_3d/30-local_multipoles.02-multipoles.inp %%DATADIR%%/testsuite/finite_systems_3d/30-local_multipoles.test %%DATADIR%%/testsuite/finite_systems_3d/31-acetylene_b3lyp.01-gs.inp %%DATADIR%%/testsuite/finite_systems_3d/31-acetylene_b3lyp.test %%DATADIR%%/testsuite/frozen/01-output_frozen.inp %%DATADIR%%/testsuite/frozen/01-output_frozen.test %%DATADIR%%/testsuite/frozen/02-na2.00-output_frozen.inp %%DATADIR%%/testsuite/frozen/02-na2.01-mixpot.inp %%DATADIR%%/testsuite/frozen/02-na2.02-mixpot.inp %%DATADIR%%/testsuite/frozen/02-na2.03-mixpot.inp %%DATADIR%%/testsuite/frozen/02-na2.04-mixrho.inp %%DATADIR%%/testsuite/frozen/02-na2.test %%DATADIR%%/testsuite/frozen/03-lih2o.00-output.inp %%DATADIR%%/testsuite/frozen/03-lih2o.01.inp %%DATADIR%%/testsuite/frozen/03-lih2o.02.inp %%DATADIR%%/testsuite/frozen/03-lih2o.03.inp %%DATADIR%%/testsuite/frozen/03-lih2o.test %%DATADIR%%/testsuite/frozen/04-na2-spin.00-output.inp %%DATADIR%%/testsuite/frozen/04-na2-spin.01-mixpot.inp %%DATADIR%%/testsuite/frozen/04-na2-spin.02-mixpot.inp %%DATADIR%%/testsuite/frozen/04-na2-spin.03-mixrho.inp %%DATADIR%%/testsuite/frozen/04-na2-spin.04-mixrho.inp %%DATADIR%%/testsuite/frozen/04-na2-spin.test %%DATADIR%%/testsuite/frozen/05-lih2o.00-output.inp %%DATADIR%%/testsuite/frozen/05-lih2o.01.inp %%DATADIR%%/testsuite/frozen/05-lih2o.02.inp %%DATADIR%%/testsuite/frozen/05-lih2o.03.inp %%DATADIR%%/testsuite/frozen/05-lih2o.04.inp %%DATADIR%%/testsuite/frozen/05-lih2o.test %%DATADIR%%/testsuite/frozen/06-kf.gga_k_absp1.inp %%DATADIR%%/testsuite/frozen/06-kf.gga_k_absp2.inp %%DATADIR%%/testsuite/frozen/06-kf.gga_k_apbe.inp %%DATADIR%%/testsuite/frozen/06-kf.gga_k_apbeint.inp %%DATADIR%%/testsuite/frozen/06-kf.gga_k_baltin.inp %%DATADIR%%/testsuite/frozen/06-kf.gga_k_dk.inp %%DATADIR%%/testsuite/frozen/06-kf.gga_k_ernzerhof.inp %%DATADIR%%/testsuite/frozen/06-kf.gga_k_fr_b88.inp %%DATADIR%%/testsuite/frozen/06-kf.gga_k_fr_pw86.inp %%DATADIR%%/testsuite/frozen/06-kf.gga_k_ge2.inp %%DATADIR%%/testsuite/frozen/06-kf.gga_k_golden.inp %%DATADIR%%/testsuite/frozen/06-kf.gga_k_gp85.inp %%DATADIR%%/testsuite/frozen/06-kf.gga_k_gr.inp %%DATADIR%%/testsuite/frozen/06-kf.gga_k_lc94.inp %%DATADIR%%/testsuite/frozen/06-kf.gga_k_lieb.inp %%DATADIR%%/testsuite/frozen/06-kf.gga_k_llp.inp %%DATADIR%%/testsuite/frozen/06-kf.gga_k_ludena.inp %%DATADIR%%/testsuite/frozen/06-kf.gga_k_meyer.inp %%DATADIR%%/testsuite/frozen/06-kf.gga_k_ol1.inp %%DATADIR%%/testsuite/frozen/06-kf.gga_k_ol2.inp %%DATADIR%%/testsuite/frozen/06-kf.gga_k_pearson.inp %%DATADIR%%/testsuite/frozen/06-kf.gga_k_perdew.inp %%DATADIR%%/testsuite/frozen/06-kf.gga_k_revapbe.inp %%DATADIR%%/testsuite/frozen/06-kf.gga_k_revapbeint.inp %%DATADIR%%/testsuite/frozen/06-kf.gga_k_tfvw.inp %%DATADIR%%/testsuite/frozen/06-kf.gga_k_thakkar.inp %%DATADIR%%/testsuite/frozen/06-kf.gga_k_tw1.inp %%DATADIR%%/testsuite/frozen/06-kf.gga_k_tw2.inp %%DATADIR%%/testsuite/frozen/06-kf.gga_k_tw3.inp %%DATADIR%%/testsuite/frozen/06-kf.gga_k_tw4.inp %%DATADIR%%/testsuite/frozen/06-kf.gga_k_vjks.inp %%DATADIR%%/testsuite/frozen/06-kf.gga_k_vsk.inp %%DATADIR%%/testsuite/frozen/06-kf.gga_k_vw.inp %%DATADIR%%/testsuite/frozen/06-kf.gga_k_yt65.inp %%DATADIR%%/testsuite/frozen/06-kf.lda_k_lp.inp %%DATADIR%%/testsuite/frozen/06-kf.lda_k_tf.inp %%DATADIR%%/testsuite/frozen/06-kf.lxc-1.1.0.test %%DATADIR%%/testsuite/frozen/06-kf.lxc-2.1.0.test %%DATADIR%%/testsuite/frozen/06-kf.none.inp %%DATADIR%%/testsuite/frozen/06-kf.output.inp %%DATADIR%%/testsuite/frozen/07-kf-spin.gga_k_absp1.inp %%DATADIR%%/testsuite/frozen/07-kf-spin.gga_k_absp2.inp %%DATADIR%%/testsuite/frozen/07-kf-spin.gga_k_apbe.inp %%DATADIR%%/testsuite/frozen/07-kf-spin.gga_k_apbeint.inp %%DATADIR%%/testsuite/frozen/07-kf-spin.gga_k_baltin.inp %%DATADIR%%/testsuite/frozen/07-kf-spin.gga_k_dk.inp %%DATADIR%%/testsuite/frozen/07-kf-spin.gga_k_ernzerhof.inp %%DATADIR%%/testsuite/frozen/07-kf-spin.gga_k_fr_b88.inp %%DATADIR%%/testsuite/frozen/07-kf-spin.gga_k_fr_pw86.inp %%DATADIR%%/testsuite/frozen/07-kf-spin.gga_k_ge2.inp %%DATADIR%%/testsuite/frozen/07-kf-spin.gga_k_golden.inp %%DATADIR%%/testsuite/frozen/07-kf-spin.gga_k_gp85.inp %%DATADIR%%/testsuite/frozen/07-kf-spin.gga_k_gr.inp %%DATADIR%%/testsuite/frozen/07-kf-spin.gga_k_lc94.inp %%DATADIR%%/testsuite/frozen/07-kf-spin.gga_k_lieb.inp %%DATADIR%%/testsuite/frozen/07-kf-spin.gga_k_llp.inp %%DATADIR%%/testsuite/frozen/07-kf-spin.gga_k_ludena.inp %%DATADIR%%/testsuite/frozen/07-kf-spin.gga_k_meyer.inp %%DATADIR%%/testsuite/frozen/07-kf-spin.gga_k_ol1.inp %%DATADIR%%/testsuite/frozen/07-kf-spin.gga_k_ol2.inp %%DATADIR%%/testsuite/frozen/07-kf-spin.gga_k_pearson.inp %%DATADIR%%/testsuite/frozen/07-kf-spin.gga_k_perdew.inp %%DATADIR%%/testsuite/frozen/07-kf-spin.gga_k_revapbe.inp %%DATADIR%%/testsuite/frozen/07-kf-spin.gga_k_revapbeint.inp %%DATADIR%%/testsuite/frozen/07-kf-spin.gga_k_tfvw.inp %%DATADIR%%/testsuite/frozen/07-kf-spin.gga_k_thakkar.inp %%DATADIR%%/testsuite/frozen/07-kf-spin.gga_k_tw1.inp %%DATADIR%%/testsuite/frozen/07-kf-spin.gga_k_tw2.inp %%DATADIR%%/testsuite/frozen/07-kf-spin.gga_k_tw3.inp %%DATADIR%%/testsuite/frozen/07-kf-spin.gga_k_tw4.inp %%DATADIR%%/testsuite/frozen/07-kf-spin.gga_k_vjks.inp %%DATADIR%%/testsuite/frozen/07-kf-spin.gga_k_vsk.inp %%DATADIR%%/testsuite/frozen/07-kf-spin.gga_k_vw.inp %%DATADIR%%/testsuite/frozen/07-kf-spin.gga_k_yt65.inp %%DATADIR%%/testsuite/frozen/07-kf-spin.lda_k_lp.inp %%DATADIR%%/testsuite/frozen/07-kf-spin.lda_k_tf.inp %%DATADIR%%/testsuite/frozen/07-kf-spin.lxc-1.1.0.test %%DATADIR%%/testsuite/frozen/07-kf-spin.lxc-2.1.0.test %%DATADIR%%/testsuite/frozen/07-kf-spin.none.inp %%DATADIR%%/testsuite/frozen/07-kf-spin.output.inp %%DATADIR%%/testsuite/functionals/01-xc_1d.01-wfs-lda.inp %%DATADIR%%/testsuite/functionals/01-xc_1d.02-wfs-hf.inp %%DATADIR%%/testsuite/functionals/01-xc_1d.lda_csc.inp %%DATADIR%%/testsuite/functionals/01-xc_1d.oep_exx.inp %%DATADIR%%/testsuite/functionals/01-xc_1d.oep_kli.inp %%DATADIR%%/testsuite/functionals/01-xc_1d.test %%DATADIR%%/testsuite/functionals/02-xc_2d.00-hartree.inp %%DATADIR%%/testsuite/functionals/02-xc_2d.01-hf.inp %%DATADIR%%/testsuite/functionals/02-xc_2d.gga_b86.inp %%DATADIR%%/testsuite/functionals/02-xc_2d.gga_b86_mgc.inp %%DATADIR%%/testsuite/functionals/02-xc_2d.gga_b88.inp %%DATADIR%%/testsuite/functionals/02-xc_2d.gga_pbe.inp %%DATADIR%%/testsuite/functionals/02-xc_2d.lda_amgb.inp %%DATADIR%%/testsuite/functionals/02-xc_2d.lda_prm.inp %%DATADIR%%/testsuite/functionals/02-xc_2d.test %%DATADIR%%/testsuite/functionals/03-xc.01-gs.inp %%DATADIR%%/testsuite/functionals/03-xc.b3lyp_fock.inp %%DATADIR%%/testsuite/functionals/03-xc.b3lyp_oep.inp %%DATADIR%%/testsuite/functionals/03-xc.exx.inp %%DATADIR%%/testsuite/functionals/03-xc.gga_c_am05.inp %%DATADIR%%/testsuite/functionals/03-xc.gga_c_lm.inp %%DATADIR%%/testsuite/functionals/03-xc.gga_c_lyp.inp %%DATADIR%%/testsuite/functionals/03-xc.gga_c_p86.inp %%DATADIR%%/testsuite/functionals/03-xc.gga_c_pbe.inp %%DATADIR%%/testsuite/functionals/03-xc.gga_c_pbe_jrgx.inp %%DATADIR%%/testsuite/functionals/03-xc.gga_c_pbe_sol.inp %%DATADIR%%/testsuite/functionals/03-xc.gga_c_pw91.inp %%DATADIR%%/testsuite/functionals/03-xc.gga_c_xpbe.inp %%DATADIR%%/testsuite/functionals/03-xc.gga_x_am05.inp %%DATADIR%%/testsuite/functionals/03-xc.gga_x_b86.inp %%DATADIR%%/testsuite/functionals/03-xc.gga_x_b86_mgc.inp %%DATADIR%%/testsuite/functionals/03-xc.gga_x_b88.inp %%DATADIR%%/testsuite/functionals/03-xc.gga_x_bayesian.inp %%DATADIR%%/testsuite/functionals/03-xc.gga_x_dk87_r1.inp %%DATADIR%%/testsuite/functionals/03-xc.gga_x_dk87_r2.inp %%DATADIR%%/testsuite/functionals/03-xc.gga_x_ft97_a.inp %%DATADIR%%/testsuite/functionals/03-xc.gga_x_ft97_b.inp %%DATADIR%%/testsuite/functionals/03-xc.gga_x_g96.inp %%DATADIR%%/testsuite/functionals/03-xc.gga_x_lb.inp %%DATADIR%%/testsuite/functionals/03-xc.gga_x_lg93.inp %%DATADIR%%/testsuite/functionals/03-xc.gga_x_mpbe.inp %%DATADIR%%/testsuite/functionals/03-xc.gga_x_mpw91.inp %%DATADIR%%/testsuite/functionals/03-xc.gga_x_optb88_vdw.inp %%DATADIR%%/testsuite/functionals/03-xc.gga_x_optpbe_vdw.inp %%DATADIR%%/testsuite/functionals/03-xc.gga_x_optx.inp %%DATADIR%%/testsuite/functionals/03-xc.gga_x_pbe.inp %%DATADIR%%/testsuite/functionals/03-xc.gga_x_pbe_jsjr.inp %%DATADIR%%/testsuite/functionals/03-xc.gga_x_pbe_r.inp %%DATADIR%%/testsuite/functionals/03-xc.gga_x_pbe_sol.inp %%DATADIR%%/testsuite/functionals/03-xc.gga_x_pbea.inp %%DATADIR%%/testsuite/functionals/03-xc.gga_x_pbek1_vdw.inp %%DATADIR%%/testsuite/functionals/03-xc.gga_x_pw86.inp %%DATADIR%%/testsuite/functionals/03-xc.gga_x_pw91.inp %%DATADIR%%/testsuite/functionals/03-xc.gga_x_rpbe.inp %%DATADIR%%/testsuite/functionals/03-xc.gga_x_wc.inp %%DATADIR%%/testsuite/functionals/03-xc.gga_x_xpbe.inp %%DATADIR%%/testsuite/functionals/03-xc.gga_xc_b97_d.inp %%DATADIR%%/testsuite/functionals/03-xc.gga_xc_edf1.inp %%DATADIR%%/testsuite/functionals/03-xc.gga_xc_hcth_120.inp %%DATADIR%%/testsuite/functionals/03-xc.gga_xc_hcth_147.inp %%DATADIR%%/testsuite/functionals/03-xc.gga_xc_hcth_407.inp %%DATADIR%%/testsuite/functionals/03-xc.gga_xc_hcth_93.inp %%DATADIR%%/testsuite/functionals/03-xc.gga_xc_mpwlyp1w.inp %%DATADIR%%/testsuite/functionals/03-xc.gga_xc_pbe1w.inp %%DATADIR%%/testsuite/functionals/03-xc.gga_xc_pbelyp1w.inp %%DATADIR%%/testsuite/functionals/03-xc.gga_xc_xlyp.inp %%DATADIR%%/testsuite/functionals/03-xc.kli.inp %%DATADIR%%/testsuite/functionals/03-xc.lda_c_gl.inp %%DATADIR%%/testsuite/functionals/03-xc.lda_c_hl.inp %%DATADIR%%/testsuite/functionals/03-xc.lda_c_ob_pw.inp %%DATADIR%%/testsuite/functionals/03-xc.lda_c_ob_pz.inp %%DATADIR%%/testsuite/functionals/03-xc.lda_c_pw.inp %%DATADIR%%/testsuite/functionals/03-xc.lda_c_pw_mod.inp %%DATADIR%%/testsuite/functionals/03-xc.lda_c_pz.inp %%DATADIR%%/testsuite/functionals/03-xc.lda_c_pz_mod.inp %%DATADIR%%/testsuite/functionals/03-xc.lda_c_rpa.inp %%DATADIR%%/testsuite/functionals/03-xc.lda_c_vbh.inp %%DATADIR%%/testsuite/functionals/03-xc.lda_c_vwn.inp %%DATADIR%%/testsuite/functionals/03-xc.lda_c_vwn_rpa.inp %%DATADIR%%/testsuite/functionals/03-xc.lda_c_wigner.inp %%DATADIR%%/testsuite/functionals/03-xc.lda_c_xalpha.inp %%DATADIR%%/testsuite/functionals/03-xc.lda_x.inp %%DATADIR%%/testsuite/functionals/03-xc.lda_xc_teter93.inp %%DATADIR%%/testsuite/functionals/03-xc.pbe0_fock.inp %%DATADIR%%/testsuite/functionals/03-xc.pbe0_oep.inp %%DATADIR%%/testsuite/functionals/03-xc.sic_pz.inp %%DATADIR%%/testsuite/functionals/03-xc.test %%DATADIR%%/testsuite/functionals/04-oep.01-jellium-lsda.inp %%DATADIR%%/testsuite/functionals/04-oep.02-jellium-exx_kli.inp %%DATADIR%%/testsuite/functionals/04-oep.03-jellium-full_exx.inp %%DATADIR%%/testsuite/functionals/04-oep.test %%DATADIR%%/testsuite/functionals/05-ks_inversion.01-target_density.inp %%DATADIR%%/testsuite/functionals/05-ks_inversion.02-two_particle.inp %%DATADIR%%/testsuite/functionals/05-ks_inversion.03-inversion.inp %%DATADIR%%/testsuite/functionals/05-ks_inversion.test %%DATADIR%%/testsuite/functionals/06-rdmft.01-lda.inp %%DATADIR%%/testsuite/functionals/06-rdmft.02-gs.inp %%DATADIR%%/testsuite/functionals/06-rdmft.03-gs_grid.inp %%DATADIR%%/testsuite/functionals/06-rdmft.test %%DATADIR%%/testsuite/functionals/07-sic.01-gs.inp %%DATADIR%%/testsuite/functionals/07-sic.test %%DATADIR%%/testsuite/functionals/08-vdw_ts.01-gs.inp %%DATADIR%%/testsuite/functionals/08-vdw_ts.test %%DATADIR%%/testsuite/functionals/09-vdw_ts_sc.01-gs.inp %%DATADIR%%/testsuite/functionals/09-vdw_ts_sc.test %%DATADIR%%/testsuite/functionals/10-vdw_d3_dna.01-gs_novdw.inp %%DATADIR%%/testsuite/functionals/10-vdw_d3_dna.02-gs_d3.inp %%DATADIR%%/testsuite/functionals/10-vdw_d3_dna.test %%DATADIR%%/testsuite/functionals/10-vdw_d3_dna.xyz %%DATADIR%%/testsuite/functionals/11-vdw_d3.01-gs.inp %%DATADIR%%/testsuite/functionals/11-vdw_d3.test %%DATADIR%%/testsuite/lda_u/01-nio.01-U5-gs.inp %%DATADIR%%/testsuite/lda_u/01-nio.test %%DATADIR%%/testsuite/lda_u/02-ACBN0.01-nio.inp %%DATADIR%%/testsuite/lda_u/02-ACBN0.02-lif.inp %%DATADIR%%/testsuite/lda_u/02-ACBN0.test %%DATADIR%%/testsuite/lda_u/03-ACBN0_restricted.01-lif.inp %%DATADIR%%/testsuite/lda_u/03-ACBN0_restricted.test %%DATADIR%%/testsuite/lda_u/04-ACBN0_isolated.01-H_unpacked.inp %%DATADIR%%/testsuite/lda_u/04-ACBN0_isolated.02-H_packed.inp %%DATADIR%%/testsuite/lda_u/04-ACBN0_isolated.test %%DATADIR%%/testsuite/lda_u/05-forces.01-Na2.inp %%DATADIR%%/testsuite/lda_u/05-forces.02-Na2_go.inp %%DATADIR%%/testsuite/lda_u/05-forces.test %%DATADIR%%/testsuite/lda_u/06-laser.01-gs.inp %%DATADIR%%/testsuite/lda_u/06-laser.02-length_gauge.inp %%DATADIR%%/testsuite/lda_u/06-laser.03-velocity_gauge.inp %%DATADIR%%/testsuite/lda_u/06-laser.test %%DATADIR%%/testsuite/lda_u/07-noncollinear.01-U5-gs.inp %%DATADIR%%/testsuite/lda_u/07-noncollinear.test %%DATADIR%%/testsuite/lda_u/08-loewdin.01-Si.inp %%DATADIR%%/testsuite/lda_u/08-loewdin.test %%DATADIR%%/testsuite/linear_response/01-casida.01-gs.inp %%DATADIR%%/testsuite/linear_response/01-casida.012-vib_modes.inp %%DATADIR%%/testsuite/linear_response/01-casida.02-unocc.inp %%DATADIR%%/testsuite/linear_response/01-casida.022-unocc_restart.inp %%DATADIR%%/testsuite/linear_response/01-casida.03-casida.inp %%DATADIR%%/testsuite/linear_response/01-casida.032-casida_restart.inp %%DATADIR%%/testsuite/linear_response/01-casida.04-spectrum.inp %%DATADIR%%/testsuite/linear_response/01-casida.test %%DATADIR%%/testsuite/linear_response/02-h2o_pol_lr.01_h2o_gs.inp %%DATADIR%%/testsuite/linear_response/02-h2o_pol_lr.02_h2o_dyn_pol.inp %%DATADIR%%/testsuite/linear_response/02-h2o_pol_lr.03_h2o_dyn_pol_cmplx.inp %%DATADIR%%/testsuite/linear_response/02-h2o_pol_lr.04_h2o_susc.inp %%DATADIR%%/testsuite/linear_response/02-h2o_pol_lr.test %%DATADIR%%/testsuite/linear_response/03-vdw_sternheimer.01-ground_state.inp %%DATADIR%%/testsuite/linear_response/03-vdw_sternheimer.02-vdw.inp %%DATADIR%%/testsuite/linear_response/03-vdw_sternheimer.test %%DATADIR%%/testsuite/linear_response/04-vib_modes.01-ground_state.inp %%DATADIR%%/testsuite/linear_response/04-vib_modes.02-vib_modes.inp %%DATADIR%%/testsuite/linear_response/04-vib_modes.022-vib_modes_restart.inp %%DATADIR%%/testsuite/linear_response/04-vib_modes.test %%DATADIR%%/testsuite/linear_response/05-polarizability.01-gs.inp %%DATADIR%%/testsuite/linear_response/05-polarizability.02-sternheimer.inp %%DATADIR%%/testsuite/linear_response/05-polarizability.03-finite-diff.inp %%DATADIR%%/testsuite/linear_response/05-polarizability.test %%DATADIR%%/testsuite/linear_response/06-vib_modes_fd.01-ground_state.inp %%DATADIR%%/testsuite/linear_response/06-vib_modes_fd.01-vib_modes_fd.inp %%DATADIR%%/testsuite/linear_response/06-vib_modes_fd.test %%DATADIR%%/testsuite/optimal_control/01-asym_doublewell.01-ground_state.inp %%DATADIR%%/testsuite/optimal_control/01-asym_doublewell.02-unocc.inp %%DATADIR%%/testsuite/optimal_control/01-asym_doublewell.03-oct_run.inp %%DATADIR%%/testsuite/optimal_control/01-asym_doublewell.04-oct_run.inp %%DATADIR%%/testsuite/optimal_control/01-asym_doublewell.05-oct_run.inp %%DATADIR%%/testsuite/optimal_control/01-asym_doublewell.test %%DATADIR%%/testsuite/optimal_control/02-sym_doublewell.01-ground_state.inp %%DATADIR%%/testsuite/optimal_control/02-sym_doublewell.02-unocc.inp %%DATADIR%%/testsuite/optimal_control/02-sym_doublewell.03-oct.inp %%DATADIR%%/testsuite/optimal_control/02-sym_doublewell.test %%DATADIR%%/testsuite/optimal_control/03-localtarget.01-gs.inp %%DATADIR%%/testsuite/optimal_control/03-localtarget.02-oct.inp %%DATADIR%%/testsuite/optimal_control/03-localtarget.03-tdoct.inp %%DATADIR%%/testsuite/optimal_control/03-localtarget.04-gs-mp.inp %%DATADIR%%/testsuite/optimal_control/03-localtarget.05-oct-mp.inp %%DATADIR%%/testsuite/optimal_control/03-localtarget.test %%DATADIR%%/testsuite/optimal_control/04-box.01-ground_state.inp %%DATADIR%%/testsuite/optimal_control/04-box.02-unocc.inp %%DATADIR%%/testsuite/optimal_control/04-box.03-oct_long.inp %%DATADIR%%/testsuite/optimal_control/04-box.04-oct_long.inp %%DATADIR%%/testsuite/optimal_control/04-box.05-oct_long.inp %%DATADIR%%/testsuite/optimal_control/04-box.06-oct_long.inp %%DATADIR%%/testsuite/optimal_control/04-box.07-oct_long.inp %%DATADIR%%/testsuite/optimal_control/04-box.08-oct_long.inp %%DATADIR%%/testsuite/optimal_control/04-box.test %%DATADIR%%/testsuite/optimal_control/05-adw.01-ground_state.inp %%DATADIR%%/testsuite/optimal_control/05-adw.02-unocc.inp %%DATADIR%%/testsuite/optimal_control/05-adw.03-filter_fixed.inp %%DATADIR%%/testsuite/optimal_control/05-adw.04-filter_indirect.inp %%DATADIR%%/testsuite/optimal_control/05-adw.test %%DATADIR%%/testsuite/optimal_control/06-zbr98.01-ground_state.inp %%DATADIR%%/testsuite/optimal_control/06-zbr98.02-oct.inp %%DATADIR%%/testsuite/optimal_control/06-zbr98.test %%DATADIR%%/testsuite/optimal_control/07-qoct+tddft.01-ground_state.inp %%DATADIR%%/testsuite/optimal_control/07-qoct+tddft.02-oct.inp %%DATADIR%%/testsuite/optimal_control/07-qoct+tddft.test %%DATADIR%%/testsuite/optimal_control/08-velocities.01-ground_state.inp %%DATADIR%%/testsuite/optimal_control/08-velocities.02-oct.inp %%DATADIR%%/testsuite/optimal_control/08-velocities.test %%DATADIR%%/testsuite/optimal_control/09-density+current.01-ground_state.inp %%DATADIR%%/testsuite/optimal_control/09-density+current.02-oct.inp %%DATADIR%%/testsuite/optimal_control/09-density+current.03-tdoct.inp %%DATADIR%%/testsuite/optimal_control/09-density+current.test %%DATADIR%%/testsuite/optimal_control/10-current.01-ground_state.inp %%DATADIR%%/testsuite/optimal_control/10-current.02-oct.inp %%DATADIR%%/testsuite/optimal_control/10-current.test %%DATADIR%%/testsuite/optimal_control/11-classical.01-ground_state.inp %%DATADIR%%/testsuite/optimal_control/11-classical.02-oct.inp %%DATADIR%%/testsuite/optimal_control/11-classical.test %%DATADIR%%/testsuite/optimal_control/12-spintarget.01-ground_state.inp %%DATADIR%%/testsuite/optimal_control/12-spintarget.02-oct.inp %%DATADIR%%/testsuite/optimal_control/12-spintarget.test %%DATADIR%%/testsuite/optimal_control/13-box-nlopt.03-bobyqa.inp %%DATADIR%%/testsuite/optimal_control/13-box-nlopt.test %%DATADIR%%/testsuite/periodic_systems/01-free_electrons.01-ground_state.inp %%DATADIR%%/testsuite/periodic_systems/01-free_electrons.02-unocc.inp %%DATADIR%%/testsuite/periodic_systems/01-free_electrons.test %%DATADIR%%/testsuite/periodic_systems/02-cosine_potential.01-ground_state.inp %%DATADIR%%/testsuite/periodic_systems/02-cosine_potential.02-unocc.inp %%DATADIR%%/testsuite/periodic_systems/02-cosine_potential.test %%DATADIR%%/testsuite/periodic_systems/03-sodium_chain.01-ground_state.inp %%DATADIR%%/testsuite/periodic_systems/03-sodium_chain.02-unocc.inp %%DATADIR%%/testsuite/periodic_systems/03-sodium_chain.03-ground_state_disp.inp %%DATADIR%%/testsuite/periodic_systems/03-sodium_chain.04-unocc_disp.inp %%DATADIR%%/testsuite/periodic_systems/03-sodium_chain.test %%DATADIR%%/testsuite/periodic_systems/04-silicon.01-gs.inp %%DATADIR%%/testsuite/periodic_systems/04-silicon.02-kdotp.inp %%DATADIR%%/testsuite/periodic_systems/04-silicon.03-emresp.inp %%DATADIR%%/testsuite/periodic_systems/04-silicon.test %%DATADIR%%/testsuite/periodic_systems/05-lithium.01-gs.inp %%DATADIR%%/testsuite/periodic_systems/05-lithium.02-td.inp %%DATADIR%%/testsuite/periodic_systems/05-lithium.03-td-restart.inp %%DATADIR%%/testsuite/periodic_systems/05-lithium.04-dielectric_function.inp %%DATADIR%%/testsuite/periodic_systems/05-lithium.test %%DATADIR%%/testsuite/periodic_systems/06-h2o_pol_lr.01_gs.inp %%DATADIR%%/testsuite/periodic_systems/06-h2o_pol_lr.02_kdotp.inp %%DATADIR%%/testsuite/periodic_systems/06-h2o_pol_lr.03_emresp.inp %%DATADIR%%/testsuite/periodic_systems/06-h2o_pol_lr.test %%DATADIR%%/testsuite/periodic_systems/07-tb09.01-gs_symm.inp %%DATADIR%%/testsuite/periodic_systems/07-tb09.02-gs_nosymm.inp %%DATADIR%%/testsuite/periodic_systems/07-tb09.03-td.inp %%DATADIR%%/testsuite/periodic_systems/07-tb09.test %%DATADIR%%/testsuite/periodic_systems/08-benzene_supercell.01-gs.inp %%DATADIR%%/testsuite/periodic_systems/08-benzene_supercell.test %%DATADIR%%/testsuite/periodic_systems/09-etsf_io.01-gs.inp %%DATADIR%%/testsuite/periodic_systems/09-etsf_io.test %%DATADIR%%/testsuite/periodic_systems/10-berkeleygw.01-gs.inp %%DATADIR%%/testsuite/periodic_systems/10-berkeleygw.02-unocc.inp %%DATADIR%%/testsuite/periodic_systems/10-berkeleygw.test %%DATADIR%%/testsuite/periodic_systems/11-silicon_force.01-gs.inp %%DATADIR%%/testsuite/periodic_systems/11-silicon_force.test %%DATADIR%%/testsuite/periodic_systems/12-boron_nitride.01-gs.inp %%DATADIR%%/testsuite/periodic_systems/12-boron_nitride.test %%DATADIR%%/testsuite/periodic_systems/13-primitive.01-diamond.inp %%DATADIR%%/testsuite/periodic_systems/13-primitive.02-graphene.inp %%DATADIR%%/testsuite/periodic_systems/13-primitive.test %%DATADIR%%/testsuite/periodic_systems/14-silicon_doubleshift.01-gs.inp %%DATADIR%%/testsuite/periodic_systems/14-silicon_doubleshift.02-td.inp %%DATADIR%%/testsuite/periodic_systems/14-silicon_doubleshift.test %%DATADIR%%/testsuite/periodic_systems/15-bandstructure.01-gs.inp %%DATADIR%%/testsuite/periodic_systems/15-bandstructure.02-unocc.inp %%DATADIR%%/testsuite/periodic_systems/15-bandstructure.test %%DATADIR%%/testsuite/periodic_systems/16-sodium_chain_cylinder.01-ground_state.inp %%DATADIR%%/testsuite/periodic_systems/16-sodium_chain_cylinder.02-unocc.inp %%DATADIR%%/testsuite/periodic_systems/16-sodium_chain_cylinder.03-ground_state_disp.inp %%DATADIR%%/testsuite/periodic_systems/16-sodium_chain_cylinder.04-unocc_disp.inp %%DATADIR%%/testsuite/periodic_systems/16-sodium_chain_cylinder.test %%DATADIR%%/testsuite/photo_electron/01-h1d_lin.01-mask.inp %%DATADIR%%/testsuite/photo_electron/01-h1d_lin.02-ba.inp %%DATADIR%%/testsuite/photo_electron/01-h1d_lin.test %%DATADIR%%/testsuite/photo_electron/02-restart.01-ba.inp %%DATADIR%%/testsuite/photo_electron/02-restart.02-restart_ba.inp %%DATADIR%%/testsuite/photo_electron/02-restart.test %%DATADIR%%/testsuite/photo_electron/03-h1d_ati.01.inp %%DATADIR%%/testsuite/photo_electron/03-h1d_ati.test %%DATADIR%%/testsuite/photo_electron/04-nfft.01-ba.inp %%DATADIR%%/testsuite/photo_electron/04-nfft.02-ati.inp %%DATADIR%%/testsuite/photo_electron/04-nfft.test %%DATADIR%%/testsuite/photo_electron/05-pfft.01-gs.inp %%DATADIR%%/testsuite/photo_electron/05-pfft.02-mask.inp %%DATADIR%%/testsuite/photo_electron/05-pfft.03-ba.inp %%DATADIR%%/testsuite/photo_electron/05-pfft.test %%DATADIR%%/testsuite/photo_electron/06-2D.01-Na_gs.inp %%DATADIR%%/testsuite/photo_electron/06-2D.02-Na_few_cy.inp %%DATADIR%%/testsuite/photo_electron/06-2D.test %%DATADIR%%/testsuite/pseudopotentials/01-sg15-h.01-gs.inp %%DATADIR%%/testsuite/pseudopotentials/01-sg15-h.test %%DATADIR%%/testsuite/pseudopotentials/02-cu2_hgh.01_gs.inp %%DATADIR%%/testsuite/pseudopotentials/02-cu2_hgh.02_gs_current.inp %%DATADIR%%/testsuite/pseudopotentials/02-cu2_hgh.03_gs_current_fast.inp %%DATADIR%%/testsuite/pseudopotentials/02-cu2_hgh.test %%DATADIR%%/testsuite/pseudopotentials/03-nlcc.01-Fatom.inp %%DATADIR%%/testsuite/pseudopotentials/03-nlcc.F.UPF %%DATADIR%%/testsuite/pseudopotentials/03-nlcc.test %%DATADIR%%/testsuite/pseudopotentials/04-carbon_dojo_psml.01-gs.inp %%DATADIR%%/testsuite/pseudopotentials/04-carbon_dojo_psml.pseudo.psml %%DATADIR%%/testsuite/pseudopotentials/04-carbon_dojo_psml.test %%DATADIR%%/testsuite/pseudopotentials/05-carbon_dojo_pbesol.01-gs.inp %%DATADIR%%/testsuite/pseudopotentials/05-carbon_dojo_pbesol.test %%DATADIR%%/testsuite/pseudopotentials/06-carbon_dojo_pbe.01-gs.inp %%DATADIR%%/testsuite/pseudopotentials/06-carbon_dojo_pbe.test %%DATADIR%%/testsuite/pseudopotentials/07-carbon_dojo_lda.01-gs.inp %%DATADIR%%/testsuite/pseudopotentials/07-carbon_dojo_lda.test %%DATADIR%%/testsuite/pseudopotentials/08-carbon_fhi.01-C.fhi %%DATADIR%%/testsuite/pseudopotentials/08-carbon_fhi.01-gs.inp %%DATADIR%%/testsuite/pseudopotentials/08-carbon_fhi.test %%DATADIR%%/testsuite/pseudopotentials/09-carbon_cpi.01-gs.inp %%DATADIR%%/testsuite/pseudopotentials/09-carbon_cpi.C.cpi %%DATADIR%%/testsuite/pseudopotentials/09-carbon_cpi.test %%DATADIR%%/testsuite/pseudopotentials/10-helium_upf.01-gs_nofilter.inp %%DATADIR%%/testsuite/pseudopotentials/10-helium_upf.02-gs_filter_ts.inp %%DATADIR%%/testsuite/pseudopotentials/10-helium_upf.03-gs_filter_bsb.inp %%DATADIR%%/testsuite/pseudopotentials/10-helium_upf.pbe-mt.UPF %%DATADIR%%/testsuite/pseudopotentials/10-helium_upf.test %%DATADIR%%/testsuite/pseudopotentials/11-isotopes.01-deuterium.inp %%DATADIR%%/testsuite/pseudopotentials/11-isotopes.02-tritium.inp %%DATADIR%%/testsuite/pseudopotentials/11-isotopes.test %%DATADIR%%/testsuite/pseudopotentials/12_mix_and_match.01-mgo.inp %%DATADIR%%/testsuite/pseudopotentials/12_mix_and_match.test %%DATADIR%%/testsuite/pseudopotentials/13-U235.01-gs.inp %%DATADIR%%/testsuite/pseudopotentials/13-U235.test %%DATADIR%%/testsuite/real_time/01-propagators.01-gs.inp %%DATADIR%%/testsuite/real_time/01-propagators.02-expmid.inp %%DATADIR%%/testsuite/real_time/01-propagators.03-etrs.inp %%DATADIR%%/testsuite/real_time/01-propagators.04-aetrs.inp %%DATADIR%%/testsuite/real_time/01-propagators.05-caetrs.inp %%DATADIR%%/testsuite/real_time/01-propagators.06-cn.inp %%DATADIR%%/testsuite/real_time/01-propagators.07-magnus.inp %%DATADIR%%/testsuite/real_time/01-propagators.08-exprk4.inp %%DATADIR%%/testsuite/real_time/01-propagators.09-cfmagnus4.inp %%DATADIR%%/testsuite/real_time/01-propagators.test %%DATADIR%%/testsuite/real_time/02-propagators.01-gs.inp %%DATADIR%%/testsuite/real_time/02-propagators.02-cnsparskit.inp %%DATADIR%%/testsuite/real_time/02-propagators.03-rungekutta2.inp %%DATADIR%%/testsuite/real_time/02-propagators.04-rungekutta4.inp %%DATADIR%%/testsuite/real_time/02-propagators.test %%DATADIR%%/testsuite/real_time/03-td_self_consistent.01-gs.inp %%DATADIR%%/testsuite/real_time/03-td_self_consistent.02-etrs.inp %%DATADIR%%/testsuite/real_time/03-td_self_consistent.test %%DATADIR%%/testsuite/real_time/05-time_propagation.01-gs.inp %%DATADIR%%/testsuite/real_time/05-time_propagation.02-td_domains.inp %%DATADIR%%/testsuite/real_time/05-time_propagation.03-td_domains_states.inp %%DATADIR%%/testsuite/real_time/05-time_propagation.04-td_md.inp %%DATADIR%%/testsuite/real_time/05-time_propagation.05-td_fast_md.inp %%DATADIR%%/testsuite/real_time/05-time_propagation.test %%DATADIR%%/testsuite/real_time/06-caetrs.01-gs.inp %%DATADIR%%/testsuite/real_time/06-caetrs.02-kick.inp %%DATADIR%%/testsuite/real_time/06-caetrs.03-kick-tp1.inp %%DATADIR%%/testsuite/real_time/06-caetrs.04-kick-tp2.inp %%DATADIR%%/testsuite/real_time/06-caetrs.test %%DATADIR%%/testsuite/real_time/08-laser.01-ground_state.inp %%DATADIR%%/testsuite/real_time/08-laser.02-length_gauge.inp %%DATADIR%%/testsuite/real_time/08-laser.03-velocity_gauge.inp %%DATADIR%%/testsuite/real_time/08-laser.04-velocity_gauge_cheby.inp %%DATADIR%%/testsuite/real_time/08-laser.test %%DATADIR%%/testsuite/real_time/09-angular_momentum.01-gs.inp %%DATADIR%%/testsuite/real_time/09-angular_momentum.02-td_gipaw.inp %%DATADIR%%/testsuite/real_time/09-angular_momentum.03-td_icl.inp %%DATADIR%%/testsuite/real_time/09-angular_momentum.04-rotatory_strength.inp %%DATADIR%%/testsuite/real_time/09-angular_momentum.test %%DATADIR%%/testsuite/real_time/10-bomd.01-gs.inp %%DATADIR%%/testsuite/real_time/10-bomd.02-td.inp %%DATADIR%%/testsuite/real_time/10-bomd.03-td_restart.inp %%DATADIR%%/testsuite/real_time/10-bomd.04-xyz-anim.inp %%DATADIR%%/testsuite/real_time/10-bomd.test %%DATADIR%%/testsuite/real_time/11-tdmagnetic.01-gs.inp %%DATADIR%%/testsuite/real_time/11-tdmagnetic.02-unocc.inp %%DATADIR%%/testsuite/real_time/11-tdmagnetic.03-td.inp %%DATADIR%%/testsuite/real_time/11-tdmagnetic.test %%DATADIR%%/testsuite/real_time/12-absorption.01-gs.inp %%DATADIR%%/testsuite/real_time/12-absorption.02-td.inp %%DATADIR%%/testsuite/real_time/12-absorption.03-td-restart.inp %%DATADIR%%/testsuite/real_time/12-absorption.04-spectrum.inp %%DATADIR%%/testsuite/real_time/12-absorption.05-spectrum_compressed_sensing.inp %%DATADIR%%/testsuite/real_time/12-absorption.06-power_spectrum.inp %%DATADIR%%/testsuite/real_time/12-absorption.07-spectrum_cosine.inp %%DATADIR%%/testsuite/real_time/12-absorption.08-spectrum_exp.inp %%DATADIR%%/testsuite/real_time/12-absorption.test %%DATADIR%%/testsuite/real_time/13-absorption-spin.01-gs.inp %%DATADIR%%/testsuite/real_time/13-absorption-spin.02-td.inp %%DATADIR%%/testsuite/real_time/13-absorption-spin.03-td-restart.inp %%DATADIR%%/testsuite/real_time/13-absorption-spin.04-spectrum.inp %%DATADIR%%/testsuite/real_time/13-absorption-spin.05-spectrum_compressed_sensing.inp %%DATADIR%%/testsuite/real_time/13-absorption-spin.06-td_spinkick.inp %%DATADIR%%/testsuite/real_time/13-absorption-spin.07-spectrum_triplet.inp %%DATADIR%%/testsuite/real_time/13-absorption-spin.test %%DATADIR%%/testsuite/real_time/14-absorption-spinors.01-gs.inp %%DATADIR%%/testsuite/real_time/14-absorption-spinors.02-td.inp %%DATADIR%%/testsuite/real_time/14-absorption-spinors.03-td-restart.inp %%DATADIR%%/testsuite/real_time/14-absorption-spinors.04-spectrum.inp %%DATADIR%%/testsuite/real_time/14-absorption-spinors.05-spectrum_compressed_sensing.inp %%DATADIR%%/testsuite/real_time/14-absorption-spinors.test %%DATADIR%%/testsuite/real_time/15-crank_nicolson.01-gs.inp %%DATADIR%%/testsuite/real_time/15-crank_nicolson.02-kick.inp %%DATADIR%%/testsuite/real_time/15-crank_nicolson.test %%DATADIR%%/testsuite/real_time/16-sparskit.01-gs.inp %%DATADIR%%/testsuite/real_time/16-sparskit.02-kick.inp %%DATADIR%%/testsuite/real_time/16-sparskit.test %%DATADIR%%/testsuite/real_time/17-absorption-spin_symmetry.01-gs.inp %%DATADIR%%/testsuite/real_time/17-absorption-spin_symmetry.02-td.inp %%DATADIR%%/testsuite/real_time/17-absorption-spin_symmetry.03-spectrum.inp %%DATADIR%%/testsuite/real_time/17-absorption-spin_symmetry.test %%DATADIR%%/testsuite/real_time/18-hhg.01-gs.inp %%DATADIR%%/testsuite/real_time/18-hhg.02-td.inp %%DATADIR%%/testsuite/real_time/18-hhg.03-hs.inp %%DATADIR%%/testsuite/real_time/18-hhg.test %%DATADIR%%/testsuite/real_time/19-td_move_ions.01-gs.inp %%DATADIR%%/testsuite/real_time/19-td_move_ions.02-td.inp %%DATADIR%%/testsuite/real_time/19-td_move_ions.03-td_restart.inp %%DATADIR%%/testsuite/real_time/19-td_move_ions.test %%DATADIR%%/testsuite/symmetries/01-triclinic.01-spg1.inp %%DATADIR%%/testsuite/symmetries/01-triclinic.02-spg2.inp %%DATADIR%%/testsuite/symmetries/01-triclinic.test %%DATADIR%%/testsuite/symmetries/02-monoclinic.01-spg3.inp %%DATADIR%%/testsuite/symmetries/02-monoclinic.02-spg4.inp %%DATADIR%%/testsuite/symmetries/02-monoclinic.03-spg5.inp %%DATADIR%%/testsuite/symmetries/02-monoclinic.04-spg6.inp %%DATADIR%%/testsuite/symmetries/02-monoclinic.05-spg7.inp %%DATADIR%%/testsuite/symmetries/02-monoclinic.06-spg8.inp %%DATADIR%%/testsuite/symmetries/02-monoclinic.07-spg9.inp %%DATADIR%%/testsuite/symmetries/02-monoclinic.08-spg10.inp %%DATADIR%%/testsuite/symmetries/02-monoclinic.09-spg11.inp %%DATADIR%%/testsuite/symmetries/02-monoclinic.10-spg12.inp %%DATADIR%%/testsuite/symmetries/02-monoclinic.11-spg13.inp %%DATADIR%%/testsuite/symmetries/02-monoclinic.12-spg14.inp %%DATADIR%%/testsuite/symmetries/02-monoclinic.13-spg15.inp %%DATADIR%%/testsuite/symmetries/02-monoclinic.test %%DATADIR%%/testsuite/symmetries/03-orthorombic.01-spg16.inp %%DATADIR%%/testsuite/symmetries/03-orthorombic.02-spg17.inp %%DATADIR%%/testsuite/symmetries/03-orthorombic.03-spg18.inp %%DATADIR%%/testsuite/symmetries/03-orthorombic.04-spg19.inp %%DATADIR%%/testsuite/symmetries/03-orthorombic.05-spg20.inp %%DATADIR%%/testsuite/symmetries/03-orthorombic.06-spg21.inp %%DATADIR%%/testsuite/symmetries/03-orthorombic.07-spg22.inp %%DATADIR%%/testsuite/symmetries/03-orthorombic.08-spg23.inp %%DATADIR%%/testsuite/symmetries/03-orthorombic.09-spg24.inp %%DATADIR%%/testsuite/symmetries/03-orthorombic.10-spg25.inp %%DATADIR%%/testsuite/symmetries/03-orthorombic.11-spg26.inp %%DATADIR%%/testsuite/symmetries/03-orthorombic.12-spg27.inp %%DATADIR%%/testsuite/symmetries/03-orthorombic.13-spg28.inp %%DATADIR%%/testsuite/symmetries/03-orthorombic.14-spg29.inp %%DATADIR%%/testsuite/symmetries/03-orthorombic.15-spg30.inp %%DATADIR%%/testsuite/symmetries/03-orthorombic.16-spg31.inp %%DATADIR%%/testsuite/symmetries/03-orthorombic.17-spg32.inp %%DATADIR%%/testsuite/symmetries/03-orthorombic.18-spg33.inp %%DATADIR%%/testsuite/symmetries/03-orthorombic.19-spg34.inp %%DATADIR%%/testsuite/symmetries/03-orthorombic.20-spg35.inp %%DATADIR%%/testsuite/symmetries/03-orthorombic.21-spg36.inp %%DATADIR%%/testsuite/symmetries/03-orthorombic.22-spg37.inp %%DATADIR%%/testsuite/symmetries/03-orthorombic.23-spg38.inp %%DATADIR%%/testsuite/symmetries/03-orthorombic.24-spg39.inp %%DATADIR%%/testsuite/symmetries/03-orthorombic.25-spg40.inp %%DATADIR%%/testsuite/symmetries/03-orthorombic.26-spg41.inp %%DATADIR%%/testsuite/symmetries/03-orthorombic.27-spg42.inp %%DATADIR%%/testsuite/symmetries/03-orthorombic.28-spg43.inp %%DATADIR%%/testsuite/symmetries/03-orthorombic.29-spg44.inp %%DATADIR%%/testsuite/symmetries/03-orthorombic.30-spg45.inp %%DATADIR%%/testsuite/symmetries/03-orthorombic.31-spg46.inp %%DATADIR%%/testsuite/symmetries/03-orthorombic.32-spg47.inp %%DATADIR%%/testsuite/symmetries/03-orthorombic.33-spg48.inp %%DATADIR%%/testsuite/symmetries/03-orthorombic.34-spg49.inp %%DATADIR%%/testsuite/symmetries/03-orthorombic.35-spg50.inp %%DATADIR%%/testsuite/symmetries/03-orthorombic.36-spg51.inp %%DATADIR%%/testsuite/symmetries/03-orthorombic.37-spg52.inp %%DATADIR%%/testsuite/symmetries/03-orthorombic.38-spg53.inp %%DATADIR%%/testsuite/symmetries/03-orthorombic.39-spg54.inp %%DATADIR%%/testsuite/symmetries/03-orthorombic.40-spg55.inp %%DATADIR%%/testsuite/symmetries/03-orthorombic.41-spg56.inp %%DATADIR%%/testsuite/symmetries/03-orthorombic.42-spg57.inp %%DATADIR%%/testsuite/symmetries/03-orthorombic.43-spg58.inp %%DATADIR%%/testsuite/symmetries/03-orthorombic.44-spg59.inp %%DATADIR%%/testsuite/symmetries/03-orthorombic.45-spg60.inp %%DATADIR%%/testsuite/symmetries/03-orthorombic.46-spg61.inp %%DATADIR%%/testsuite/symmetries/03-orthorombic.47-spg62.inp %%DATADIR%%/testsuite/symmetries/03-orthorombic.48-spg63.inp %%DATADIR%%/testsuite/symmetries/03-orthorombic.49-spg64.inp %%DATADIR%%/testsuite/symmetries/03-orthorombic.50-spg65.inp %%DATADIR%%/testsuite/symmetries/03-orthorombic.51-spg66.inp %%DATADIR%%/testsuite/symmetries/03-orthorombic.52-spg67.inp %%DATADIR%%/testsuite/symmetries/03-orthorombic.53-spg68.inp %%DATADIR%%/testsuite/symmetries/03-orthorombic.54-spg69.inp %%DATADIR%%/testsuite/symmetries/03-orthorombic.55-spg70.inp %%DATADIR%%/testsuite/symmetries/03-orthorombic.56-spg71.inp %%DATADIR%%/testsuite/symmetries/03-orthorombic.57-spg72.inp %%DATADIR%%/testsuite/symmetries/03-orthorombic.58-spg73.inp %%DATADIR%%/testsuite/symmetries/03-orthorombic.59-spg74.inp %%DATADIR%%/testsuite/symmetries/03-orthorombic.test %%DATADIR%%/testsuite/symmetries/04-tetragonal.01-spg75.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.02-spg76.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.03-spg77.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.04-spg78.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.05-spg79.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.06-spg80.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.07-spg81.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.08-spg82.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.09-spg83.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.10-spg84.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.11-spg85.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.12-spg86.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.13-spg87.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.14-spg88.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.15-spg89.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.16-spg90.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.17-spg91.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.18-spg92.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.19-spg93.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.20-spg94.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.21-spg95.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.22-spg96.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.23-spg97.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.24-spg98.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.25-spg99.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.26-spg100.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.27-spg101.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.28-spg102.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.29-spg103.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.30-spg104.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.31-spg105.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.32-spg106.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.33-spg107.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.34-spg108.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.35-spg109.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.36-spg110.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.37-spg111.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.38-spg112.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.39-spg113.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.40-spg114.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.41-spg115.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.42-spg116.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.43-spg117.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.44-spg118.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.45-spg119.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.46-spg120.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.47-spg121.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.48-spg122.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.49-spg123.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.50-spg124.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.51-spg125.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.52-spg126.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.53-spg127.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.54-spg128.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.55-spg129.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.56-spg130.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.57-spg131.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.58-spg132.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.59-spg133.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.60-spg134.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.61-spg135.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.62-spg136.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.63-spg137.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.64-spg138.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.65-spg139.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.66-spg140.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.67-spg141.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.68-spg142.inp %%DATADIR%%/testsuite/symmetries/04-tetragonal.test %%DATADIR%%/testsuite/symmetries/05-hexagonal.01-spg143.inp %%DATADIR%%/testsuite/symmetries/05-hexagonal.02-spg144.inp %%DATADIR%%/testsuite/symmetries/05-hexagonal.03-spg145.inp %%DATADIR%%/testsuite/symmetries/05-hexagonal.04-spg146.inp %%DATADIR%%/testsuite/symmetries/05-hexagonal.05-spg147.inp %%DATADIR%%/testsuite/symmetries/05-hexagonal.06-spg148.inp %%DATADIR%%/testsuite/symmetries/05-hexagonal.07-spg149.inp %%DATADIR%%/testsuite/symmetries/05-hexagonal.08-spg150.inp %%DATADIR%%/testsuite/symmetries/05-hexagonal.09-spg151.inp %%DATADIR%%/testsuite/symmetries/05-hexagonal.10-spg152.inp %%DATADIR%%/testsuite/symmetries/05-hexagonal.11-spg153.inp %%DATADIR%%/testsuite/symmetries/05-hexagonal.12-spg154.inp %%DATADIR%%/testsuite/symmetries/05-hexagonal.13-spg155.inp %%DATADIR%%/testsuite/symmetries/05-hexagonal.14-spg156.inp %%DATADIR%%/testsuite/symmetries/05-hexagonal.15-spg157.inp %%DATADIR%%/testsuite/symmetries/05-hexagonal.16-spg158.inp %%DATADIR%%/testsuite/symmetries/05-hexagonal.17-spg159.inp %%DATADIR%%/testsuite/symmetries/05-hexagonal.18-spg160.inp %%DATADIR%%/testsuite/symmetries/05-hexagonal.19-spg161.inp %%DATADIR%%/testsuite/symmetries/05-hexagonal.20-spg162.inp %%DATADIR%%/testsuite/symmetries/05-hexagonal.21-spg163.inp %%DATADIR%%/testsuite/symmetries/05-hexagonal.22-spg164.inp %%DATADIR%%/testsuite/symmetries/05-hexagonal.23-spg165.inp %%DATADIR%%/testsuite/symmetries/05-hexagonal.24-spg166.inp %%DATADIR%%/testsuite/symmetries/05-hexagonal.25-spg167.inp %%DATADIR%%/testsuite/symmetries/05-hexagonal.26-spg168.inp %%DATADIR%%/testsuite/symmetries/05-hexagonal.27-spg169.inp %%DATADIR%%/testsuite/symmetries/05-hexagonal.28-spg170.inp %%DATADIR%%/testsuite/symmetries/05-hexagonal.29-spg171.inp %%DATADIR%%/testsuite/symmetries/05-hexagonal.30-spg172.inp %%DATADIR%%/testsuite/symmetries/05-hexagonal.31-spg173.inp %%DATADIR%%/testsuite/symmetries/05-hexagonal.32-spg174.inp %%DATADIR%%/testsuite/symmetries/05-hexagonal.33-spg175.inp %%DATADIR%%/testsuite/symmetries/05-hexagonal.34-spg176.inp %%DATADIR%%/testsuite/symmetries/05-hexagonal.35-spg177.inp %%DATADIR%%/testsuite/symmetries/05-hexagonal.36-spg178.inp %%DATADIR%%/testsuite/symmetries/05-hexagonal.37-spg179.inp %%DATADIR%%/testsuite/symmetries/05-hexagonal.38-spg180.inp %%DATADIR%%/testsuite/symmetries/05-hexagonal.39-spg181.inp %%DATADIR%%/testsuite/symmetries/05-hexagonal.40-spg182.inp %%DATADIR%%/testsuite/symmetries/05-hexagonal.41-spg183.inp %%DATADIR%%/testsuite/symmetries/05-hexagonal.42-spg184.inp %%DATADIR%%/testsuite/symmetries/05-hexagonal.43-spg185.inp %%DATADIR%%/testsuite/symmetries/05-hexagonal.44-spg186.inp %%DATADIR%%/testsuite/symmetries/05-hexagonal.45-spg187.inp %%DATADIR%%/testsuite/symmetries/05-hexagonal.46-spg188.inp %%DATADIR%%/testsuite/symmetries/05-hexagonal.47-spg189.inp %%DATADIR%%/testsuite/symmetries/05-hexagonal.48-spg190.inp %%DATADIR%%/testsuite/symmetries/05-hexagonal.49-spg191.inp %%DATADIR%%/testsuite/symmetries/05-hexagonal.50-spg192.inp %%DATADIR%%/testsuite/symmetries/05-hexagonal.51-spg193.inp %%DATADIR%%/testsuite/symmetries/05-hexagonal.52-spg194.inp %%DATADIR%%/testsuite/symmetries/05-hexagonal.test %%DATADIR%%/testsuite/symmetries/06-cubic.01-spg195.inp %%DATADIR%%/testsuite/symmetries/06-cubic.02-spg196.inp %%DATADIR%%/testsuite/symmetries/06-cubic.03-spg197.inp %%DATADIR%%/testsuite/symmetries/06-cubic.04-spg198.inp %%DATADIR%%/testsuite/symmetries/06-cubic.05-spg199.inp %%DATADIR%%/testsuite/symmetries/06-cubic.06-spg200.inp %%DATADIR%%/testsuite/symmetries/06-cubic.07-spg201.inp %%DATADIR%%/testsuite/symmetries/06-cubic.08-spg202.inp %%DATADIR%%/testsuite/symmetries/06-cubic.09-spg203.inp %%DATADIR%%/testsuite/symmetries/06-cubic.10-spg204.inp %%DATADIR%%/testsuite/symmetries/06-cubic.11-spg205.inp %%DATADIR%%/testsuite/symmetries/06-cubic.12-spg206.inp %%DATADIR%%/testsuite/symmetries/06-cubic.13-spg207.inp %%DATADIR%%/testsuite/symmetries/06-cubic.14-spg208.inp %%DATADIR%%/testsuite/symmetries/06-cubic.15-spg209.inp %%DATADIR%%/testsuite/symmetries/06-cubic.16-spg210.inp %%DATADIR%%/testsuite/symmetries/06-cubic.17-spg211.inp %%DATADIR%%/testsuite/symmetries/06-cubic.18-spg212.inp %%DATADIR%%/testsuite/symmetries/06-cubic.19-spg213.inp %%DATADIR%%/testsuite/symmetries/06-cubic.20-spg214.inp %%DATADIR%%/testsuite/symmetries/06-cubic.21-spg215.inp %%DATADIR%%/testsuite/symmetries/06-cubic.22-spg216.inp %%DATADIR%%/testsuite/symmetries/06-cubic.23-spg217.inp %%DATADIR%%/testsuite/symmetries/06-cubic.24-spg218.inp %%DATADIR%%/testsuite/symmetries/06-cubic.25-spg219.inp %%DATADIR%%/testsuite/symmetries/06-cubic.26-spg220.inp %%DATADIR%%/testsuite/symmetries/06-cubic.27-spg221.inp %%DATADIR%%/testsuite/symmetries/06-cubic.28-spg222.inp %%DATADIR%%/testsuite/symmetries/06-cubic.29-spg223.inp %%DATADIR%%/testsuite/symmetries/06-cubic.30-spg224.inp %%DATADIR%%/testsuite/symmetries/06-cubic.31-spg225.inp %%DATADIR%%/testsuite/symmetries/06-cubic.32-spg226.inp %%DATADIR%%/testsuite/symmetries/06-cubic.33-spg227.inp %%DATADIR%%/testsuite/symmetries/06-cubic.34-spg228.inp %%DATADIR%%/testsuite/symmetries/06-cubic.35-spg229.inp %%DATADIR%%/testsuite/symmetries/06-cubic.36-spg230.inp %%DATADIR%%/testsuite/symmetries/06-cubic.test %%DATADIR%%/testsuite/symmetries/07-symmetrization_lda.01-spg2_sym.inp %%DATADIR%%/testsuite/symmetries/07-symmetrization_lda.02-spg16_sym.inp %%DATADIR%%/testsuite/symmetries/07-symmetrization_lda.03-spg75_sym.inp %%DATADIR%%/testsuite/symmetries/07-symmetrization_lda.test %%DATADIR%%/testsuite/symmetries/08-symmetrization_mgga.01-spg3_sym.inp %%DATADIR%%/testsuite/symmetries/08-symmetrization_mgga.test %%DATADIR%%/testsuite/symmetries/09-symmetrization_gga.01-spg143_sym.inp %%DATADIR%%/testsuite/symmetries/09-symmetrization_gga.test %%DATADIR%%/util/README %%DATADIR%%/util/display_mesh_index.gp %%DATADIR%%/util/mf.cfg %%DATADIR%%/util/mf.net %%DATADIR%%/variables %%DATADIR%%/varinfo