3
0
mirror of https://github.com/triqs/dft_tools synced 2024-06-25 06:32:22 +02:00

Elk converter (#151)

Adding Elk-TRIQS interface (first iteration) 

This interface reads in Elk's ground-state files / projectors generated by a specific Elk interface code version (https://github.com/AlynJ/Elk_interface-TRIQS). The interface can perform charge-self consistent DFT+DMFT calculations using the aforementioned Elk code version, including spin orbit-coupling. Hence, this is the first open source interfaced DFT code to triqs with FCSC support. 

The commit includes detailed documentation and tutorials on how to use this interface. Moreover, further new post-processing routines are added for Fermi surface plots and spectral functions (A(w)) from the elk inputs.

The interface was tested by A. James and A. Hampel. However, this is the first iteration of the interface and should be used with care. Please report all bugs.

List of changes:
---------------
- sumk.py: added cacluation of charge density correction for elk (dm_type='elk').
- sumk_dft_tools.py: added new post-processing functions to calculate the Fermi surface and A(w) from the Elk inputs.
- documentation and tutorial files amended for this interface.
- added python tests for the Elk converter.
This commit is contained in:
AlynJ 2020-10-09 13:35:28 +01:00 committed by GitHub
parent 966ebabd79
commit ad8c4e75fe
No known key found for this signature in database
GPG Key ID: 4AEE18F83AFDEB23
32 changed files with 10341 additions and 29 deletions

View File

@ -1,6 +1,7 @@
Markus Aichhorn
Michel Ferrero
Alexander Hampel
Alyn James
Gernot Kraberger
Olivier Parcollet
Oleg Peil

View File

@ -17,7 +17,7 @@ of full charge self-consistency [#dft_tools2]_, necessary for total energy
calculations. The package at hand is fully implemented as an application
based on the TRIQS library [#dft_tools3]_.
**Developers**: M. Aichhorn, L. Pourovskii, P.Seth, V. Vildosola, M. Zingl, O. E. Peil, X. Deng, J. Mravlje, G. Kraberger, C. Martins, M. Ferrero, O. Parcollet
**Developers**: M. Aichhorn, L. Pourovskii, A. Hampel, P.Seth, V. Vildosola, M. Zingl, O. E. Peil, X. Deng, J. Mravlje, G. Kraberger, A. James, C. Martins, M. Ferrero, O. Parcollet
**Related papers**:

189
doc/guide/conv_elk.rst Normal file
View File

@ -0,0 +1,189 @@
.. _convElk:
Interface with Elk
=====================
This is the first iteration of the Elk-TRIQS interface, so certain inputs may change in later updates. The Elk part of the interface is not currently in the main distribution, but it can be found :ref:`here <https://github.com/AlynJ/Elk_interface-TRIQS>`.
We assume that the user has obtained a self-consistent solution of the
Kohn-Sham equations with Elk (a full tutorial can be found here :ref:`Elk SVO tutorial <SrVO3_elk>`). Also, the user needs to be familiar with the main in/output files of Elk, and how to run
the DFT code. Further information about Elk can be found on the :ref:`official Elk website <http://elk.sourceforge.net/>`.
Conversion for the DMFT self-consistency cycle
----------------------------------------------
Once the user has obtained the groundstate calculation, they will have to rerun Elk but with some small changes to the inputs in the elk.in file which will be explained below. The Elk part of the interface calculates and outputs the Wannier projectors. All downfolding related flags are set in the elk input file, and Elk determines automatically by symmetry equivalent sites. The TRIQS Elk converter then reads in these projectors along with the other Elk ascii files which would have been generated in the Elk ground state calculation. This information is then packed into the HDF5 file.
In the following, we use SrVO3 as an example to explain the flags required in the elk.in input file. An example elk.in of SrVO3 is available in the :ref:`SrVO3 tutorial <elk_SVO>`.
.. literalinclude:: ../tutorials/images_scripts/elk.in_SVO
The projectors are generated in Elk using these alterations in the elk.in file::
task
805
wanproj
1 !1) number of projector species
2 2 3 !2) species number, l value and lm submatrix size
7 8 9 !3) cubic harmonic lm indices
-0.055 0.07 !4) Correlated energy window in Hartrees (this is [-1.5, 1.9] in eV)
The first flag "task" specifies Elk to do the Wannier projector calculation in the Elk input convention. The "wanproj" flag specifies the information needed to generate the desired projectors (the exclamation marks are comment flags in Fortran). Below gives the meaning of each line:
#. The number of different species to generate the projectors for. If the material has multiple atoms of the same species, then the projectors will be generated for all of these atoms. Information about whether these atoms are symmetrically equivalent is written to the PROJ.OUT file. Generating projectors for multiple species requires lines 2) and 3) to be repeated for each projector species.
#. The desired species index (relative to the order of the "atoms" input in elk.in), the l value and the number of wanted lm orbitals for the projectors.
#. The lm indices (in the cubic harmonics by default) where lm = 1 refers to the s orbital, lm = 2,3,4 refers to the p orbitals, lm = 5,6,7,8,9 refers to the d orbitals and finally lm = 10,11,12,13,14,15,16 refers to the f orbitals. In the example above, this specifies that we want the t2g orbitals which has size 3 [last number in line 2)] and the lm indices are 7, 8 and 9 as specified in line 3). If, on the other hand, the user wishes to use all of the d-orbitals then all 5 orbital indices need to be included along with specifying that all 5 orbitals will be used [at the end of line 2)].
#. The correlated energy window (in Hartree) to generate the projectors within.
It should be noted that the indices in line 3) will change if another lm basis is used.
The default is the cubic harmonic basis. The flags in elk.in required to change the spherical harmonic basis are::
cubic
.true.
lmirep
.true.
Above are the default inputs. If both of these flags are set to .false., the projectors will be generated in the complex spherical harmonic basis. It is possible to generate the projectors in Elk's irreducible basis by setting cubic to .false., but this is experimental and the TRIQS side of the interface is
currently unable to convert the projectors in that basis. Finally, these projectors are written to file in the complex spherical harmonic basis.
.. _Elk_files:
The rest of the elk.in file can remain unchanged. This 805 task calculates the projectors which are written into the WANPROJ_L**_S**_A****.OUT file(s). Along with this, the other written file (PROJ.OUT) specficies some information about the projectors (like atom equivalency, lm indices and so on) needed for reading the files into the TRIQS library. The PROJ.OUT file contains comments about its outputs. Here's a list of all of the input files needed for this part of the TRIQS converter:
#. WANPROJ_L**_S**_A****.OUT - file containing the projectors and band window indices.
#. PROJ.OUT - specficies some information about the projectors.
(like atom equivalency, lm indices and so on) needed for reading into the TRIQS library.
#. EIGVAL.OUT - contains the energies and latice vector coordinates for each k-point.
#. EFERMI.OUT - contains the Fermi energy.
#. KPOINTS.OUT - contains the k-point weights and lattice vectors.
#. SYMCRYS.OUT - has the crystal symmetries used for symmetries observables.
#. LATTICE.OUT - has lattice-Cartesian basis transformation matrices.
#. GEOMETRY.OUT - file with the lattice positions of every atom of each species.
Moreover, the Wannier charge density matrix (in WANCHARGE.OUT) and the Wannier spectral function (in WANSF_L**_S**_A****_0*.OUT) are calculated. These files are not used in the interface.
As a side note, there are two other tasks which also generate the Wannier projectors. Task 804 generates the same outputs as 805 except it doesn't calculate the Wannier charge and spectral function. Task 806 outputs the same information as 805, but it generates the projectors (and other k-dependent variables) on a different user defined ngridk mesh. These tasks are parallelized with both OpenMP and MPI.
The Elk outputs are read into the TRIQS library using the following lines::
from triqs_dft_tools.converters.elk import *
Converter = ElkConverter(filename=filename, repacking=True)
Converter.convert_dft_input()
The first two lines import and load the Elk converter module and the last line executes the conversion into the filename.h5 HDF5 file.
Data for post-processing - Correlated Spectral functions
--------------------------------------------------------
In case you want to do post-processing of your data using the module :class:`SumkDFTTools <dft.sumk_dft_tools.SumkDFTTools>`, some more files have to be converted to the HDF5 archive. Some of this has been laid out in :ref:`analysis`, but the Elk specific functions are described in the following sections. Below, we will discuss how to input the information for correlated spectral functions (band structures) and which is then calculated using "spaghettis" in :ref:`analysis`. However, band character band structure plots have not yet been implemented.
In Elk, the elk.in requires the altered flag::
task
820
As well as the wanproj flag (which has be discussed previously) and the plot1d flag (refer to the Elk manual). The new output files of this task required for the interface are:
#. BAND.OUT - the energy eigenvalues along the user specified path.
#. PROJ_WANBAND.OUT - same as PROJ.OUT but for band structure projectors
#. WANPROJ_L**_S**_A****_WANBAND.OUT - same as WANPROJ_L**_S**_A****.OUT
but for band structure projectors.
(The ascii output files which have the new extension of _WANBAND.OUT are specific for this post processing calculation.)
The band structure information is converted into TRIQS by using::
Converter.convert_bands_input()
Spectral function from Elk inputs
---------------------------------
Elk does not calculate the theta projectors for partial DOS calculations. Instead, Elk outputs the band characters into the file BC.OUT when using the elk.in task::
task
803
The contents of BC.OUT need to be converted into the HDF5 file by using the Elk Converter module::
from triqs_dft_tools.converters.elk import *
Converter = ElkConverter(filename=filename, repacking=True)
Converter.dft_band_characters()
Once these have been saved to the HDF5 file (called "filename" here), the spectral function can be calculated with::
SK.elk_dos(broadening=0.0, with_Sigma=True, with_dc=True, pdos=False, nk=None)
This outputs the total spectral function and the partial spectral function if enabled. Most of the user inputs are similar to the "SK.dos_parproj_basis()" module in :ref:`analysis`. The "pdos" flag when "True" enables the partial dos of each lm value to be calculated. It should be noted that these band characters are in Elk's irreducible lm basis and as such, the user has to check the irreducible representation used in Elk. This information can be found in the file ELMIREP.OUT after running task 10 (the DOS calculating task). The "nk" flag enables the calculation of the occupied spectral funciton. Here, nk needs to be the occupation density matrix (calculated from integrating the Green's function on the Matsubara axis) in the Bloch basis. This input needs to be in the same format as the occupation density matrix "deltaN" calculated in the sumk_DFT.calc_density_correction(dm_type='elk') module.
Spectral function Contour Plots (Fermi Surfaces) from Elk inputs
---------------------------------------------------------------
Here, we will discuss how to plot the Fermi surface contour or any other non-zero omega spectral function contour plot. This is currently tailored for the Elk inputs. From this point, we will refer to these contours as Fermi surfaces. The energy eigenvalues, projectors and so on required for the Fermi surface plot needs to be outputed from Elk. This is done by using::
task
807
in Elk, but unlike the previous Elk interface tasks, the k-mesh grid needs to be specified. This is done like using the same inputs as the Fermi surface calculations in Elk. In Elk, The user needs to specify the "plot3d" input flag used to generate the k-mesh which the interface variables are evaluated on. A simple example is for SrVO3 where plot3d would look something like::
plot3d
0.0 0.0 0.0 !1) origin
1.0 0.0 0.0 !2) vertex 1
0.0 1.0 0.0 !3) vertex 2
0.0 0.0 1.0 !4) vertex 3
32 32 32 !5) k-mesh grid size
Lines 1) to 4) specifies the corners (in lattice coordinates) of the k-grid box and line 5) is the grid size in each direction (see the Elk manual). If the user desires to plot a 2D plane, then the user should define the plane using lines 2) and 3) [relative to line 1)] and define line 4) to be the cross-product of lines 2) and 3) [i.e. the vector in line 4) is normal to the 2D plane]. The outputs will be in terms of the k-dependent quantities in the irreducible Brillouin zone (IBZ). The files needed for the interface are:
#. EIGVAL_FS.OUT - same as EIGVAL.OUT but the output is of the Fermi surface calculation.
#. KPOINT_FS.OUT - same as KPOINT.OUT but the output is of the Fermi surface calculation.
#. PROJ_FS.OUT - same as PROJ.OUT but the output is of the Fermi surface calculation.
#. WANPROJ_L**_S**_A****_FS.OUT - same as WANPROJ_L**_S**_A****.OUT but the output is of the Fermi surface calculation.
#. EFERMI.OUT - contains the Fermi energy.
#. SYMCRYS.OUT - has the crystal symmetries used for symmetries observables.
#. LATTICE.OUT - has lattice-Cartesian basis transformation matrices.
(The ascii output files which have the extension of _FS.OUT are specific for this post processing calculation.)
These outputs are converted to the HDF5 file by::
from triqs_dft_tools.converters.elk import *
Converter = ElkConverter(filename=filename, repacking=True)
Converter.convert_fs_input()
The spectral function for the Fermi surface plots are calculated with::
SK.fs_plot(broadening=0.0, mesh=None, FS=True, plane=True, sym=True, orthvec=None, with_Sigma=True, with_dc=True)
The new flags specify the following:
#. "FS" - determines whether the output will be the Fermi surface and uses the closest omega value to 0.0 in the mesh.
#. "plane" - required to specify whether the Elk input parameters were generated on a k-mesh plane.
#. "sym" - needed if the IBZ will be folded out by using symmetry operations.
#. "orthvec" - (numpy array of length 3) needs to be specified if using "plane" as this input is the orthonormal vector to the 2D plane required for the folding out process.
To give the user a range of output capabilities, This routine can be used in the following ways:
#. If using "with_Sigma", the mesh will be the same as the self-energy. However, by setting FS=False, the user can input a mesh option if they desire the "Fermi surface" plots for each omega value (commensurate with the self-energy mesh) within the input range.
#. If the user is generating the DFT Spectral function plot (i.e. with_Sigma and with_dc both set to False), a mesh needs to be specified if FS=False. This function will output the spectral functions for the input mesh. Otherwise if FS is True, this would return the spectral function at omega=0.0.
The output files will have the form of "Akw_FS_X.dat" (X being either up, down or ud) if FS=True or "Akw_X_omega_Y.dat" (Y being the omega mesh index) otherwise. The latter file will have the omega values within the file (the fourth column). The first three columns of both output file types specifies the cartesian lattice vector (kx, ky, kz) and the last column is the spectral function values.
DFT+DMFT wavefunction dependent quantities
------------------------------------------
The DFT+DMFT wavefunctions and occupations are generated in Elk by diagonalizing the full DFT+DMFT density matrix at each k-point during task 808. These are used to update the electron density which is then used to solve the Kohn-Sham equations once to complete a FCSC DFT+DMFT cycle. It is possible to calculate quantities which are solely dependent on the wavefunctions and occupations by using the aforementioned diagonalized set. After generating the DMATDMFT.OUT file, these diagonalized wavefunctions and occupations are calculated by amending elk.in with the new task::
task
809
This will write the new second variational eigenvectors and occupations in the EVECSV.OUT and OCCSV.OUT binary files respectively. Then the wavefunction dependent quantities implemented within Elk can be calculated using these DFT+DMFT wavefunctions and occupations. Note that this only works for energy independent quantities. Also, the user has to ensure that the second variational eigenvectors will be used in determining the wavefunction dependent quantities. This is done by looking for the variable "tevecsv" in init0.f90 of Elk's source code and making sure that this is set to .true. for the task number the user wishes to use.

View File

@ -7,8 +7,8 @@ The first step for a DMFT calculation is to provide the necessary
input based on a DFT calculation. We will not review how to do the DFT
calculation here in this documentation, but refer the user to the
documentation and tutorials that come with the actual DFT
package. At the moment, there are two full charge self consistent interfaces, for the
Wien2k and the VASP DFT packages, resp. In addition, there is an interface to Wannier90, as well
package. At the moment, there are three full charge self consistent interfaces, for the
Wien2k, VASP and Elk DFT packages, resp. In addition, there is an interface to Wannier90, as well
as a light-weight general-purpose interface. In the following, we will describe the usage of these
conversion tools.
@ -17,6 +17,7 @@ conversion tools.
conv_wien2k
conv_vasp
conv_elk
conv_W90
conv_generalhk

View File

@ -180,6 +180,36 @@ To understand the difference please make sure to read `ISTART flag VASP wiki
`NELMIN` ensure that VASP does not terminate after the default number of
iterations of 60.
Elk
---------
The Elk CSC implementation is fairly similar to the Wien2k implementation. At the end of the :ref:`DMFT python script <SrVO3_elk>`, the density matrix in Bloch space needs to be calculated along with the correlation energy. This is written to DMATDMFT.OUT. An example of this (using the Migdal correlation energy formula) is given below::
#output the density matrix for Elk interface
dN, d = SK.calc_density_correction(dm_type='elk')
#correlation energy via the Migdal formula
correnerg = 0.5 * (S.G_iw * S.Sigma_iw).total_density()
#subtract the double counting energy
correnerg -= SK.dc_energ[0]
#convert to Hartree
correnerg = correnerg/SK.energy_unit
#save the correction to energy
if (mpi.is_master_node()):
f=open('DMATDMFT.OUT','a')
f.write("%.16f\n"%correnerg)
f.close()
To read this into Elk and update the electron density, run task 808. So elk.in is amended with the following::
task
808
This solves the Kohn-Sham equations once with the updated electron density and outputs the new set of energy eigenvalues and wavefunctions. To start the next fully charge self-consistent DFT+DMFT cycle (FCSC), a new set of projectors need to be generated (using task 805) and the whole procedure continues until convergence. The Elk potential rms value for each FCSC DFT+DMFT cycle is given in DMFT_INFO.OUT. An extensive example for SrVO:math:`_3` can be found here: :ref:`Elk SVO tutorial <SrVO3_elk>`.
This FCSC method should be universal irrespective to what type of ground state calculation performed. However, not all types of ground state calculations have been tested.
Other DFT codes
---------------

View File

@ -14,15 +14,18 @@ The second variant is a bit more involved and needs quite some expertise, so thi
Treatment of SOC in DFT
-----------------------
For now, TRIQS/DFTTools does only work with Wien2k when performing calculations with SO.
For now, TRIQS/DFTTools does only work with Wien2k and Elk when performing calculations with SO.
The treatment of SOC in the VASP package is fundamentally different to the way Wien2k treats it, and the interface does not handle that at the moment.
Therefore, this guide describes how to do an SOC calculation using the Wien2k DFT package.
Therefore, this guide describes how to do an SOC calculation using the Wien2k and Elk DFT packages.
Treatment of SOC in Wien2k
--------------------------
First, a Wien2k calculation including SOC has to be performed.
For details, we refer the reader to the `documentation of Wien2k <http://susi.theochem.tuwien.ac.at/reg_user/textbooks/>`_ . As a matter of fact, we need the output for the DFT band structure for both spin directions explicitly. That means that one needs to do a spin-polarised DFT calculation with SOC, but, however, with magnetic moment set to zero. In the Wien2k initialisation procedure, one can choose for the option -nom when ``lstart`` is called. This means that the charge densities are initialised without magnetic splitting. The SOC calculation is then performed in a standard way as described in the Wien2k manual.
Performing the projection
~~~~~~~~~~~~~~~~~~~~~~~~~
Performing the projection in Wien2k
~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~~
Note that the final ``x lapw2 -almd -so -up`` and ``x lapw2 -almd -so -dn`` have to be run *on a single core*, which implies that, before, ``x lapw2 -up``, ``x lapw2 -dn``, and ``x lapwso -up`` have to be run in single-core mode (at least once).
@ -33,6 +36,13 @@ As usual, it is important to check for warnings (e.g., about eigenvalues of the
Note that in presence of SOC, it is not possible to project only onto the :math:`t_{2g}` subshell because it is not an irreducible representation.
Treatment of SOC in Elk
-------------------------
First, a Elk calculation including SOC has to be performed. For details, we refer the reader to the SOC Elk examples in Elk's example directory and `Elk manual <https//elk.sourceforge.net/elk.pdf>`_ for further information about the input flags. Then the projectors can be generated using the ``wanproj`` input flag in the same format as in :ref:`conv_elk`. Like in Wien2k, you cannot project only onto the :math:`t_{2g}` subshell because it is not an irreducible representation in SOC calculations.
After generating the projectors
-------------------------------
We strongly suggest using the :py:meth:`.dos_wannier_basis` functionality of the :py:class:`.SumkDFTTools` class (see :download:`calculate_dos_wannier_basis.py <Sr2RuO4/calculate_dos_wannier_basis.py>`) and compare the Wannier-projected orbitals to the original DFT DOS (they should be more or less equal).
Note that, with SOC, there are usually off-diagonal elements of the spectral function, which can also be imaginary.
@ -40,4 +50,4 @@ The imaginary part can be found in the third column of the files ``DOS_wann_...`
After the projection, one can proceed with the DMFT calculation. However, two things need to be noted here. First, since the spin is not a good quantum number any more, there are off-diagonal elements in the hybridisation function and the local Hamiltonian coupling the two spin directions. This will eventually lead to a fermonic sign problem when QMC is used as a impurity solver. Second, although the :math:`e_{g}` subshell needs to be included in the projection, it can in many cases be neglected in the solution of the Anderson impurity model, after a transformation to a rotated local basis is done. This basis, diagonalising the local Hamiltonian in the presence of SOC, is often called the numerical j-basis. How rotations are performed is described in :ref:`basisrotation`, and the cutting of the orbitals in :ref:`blockstructure`.
A DMFT calculation including SOC for Sr2MgOsO6 is included in the :ref:`tutorials`.
A DMFT calculation including SOC for Sr2MgOsO6 using Wien2k is included in the :ref:`tutorials`.

View File

@ -58,6 +58,24 @@ VASP Converter
:special-members:
Elk Converter
-------------------
.. _refElkconverter:
.. autoclass:: triqs_dft_tools.converters.elk.ElkConverter
:members:
:special-members:
Elk Tools
-------------------
.. _refElkTools:
.. autoclass:: triqs_dft_tools.converters.elktools.ElkConverterTools
:members:
:special-members:
.. autoclass:: triqs_dft_tools.converters.elktools.readElkfiles
:members:
:special-members:
Converter Tools
---------------
.. autoclass:: triqs_dft_tools.converters.converter_tools.ConverterTools

View File

@ -60,3 +60,16 @@ Complex example: NiO
tutorials/nio_csc
Elk interface examples
-----------------------
Converter example: SrVO3
""""""""""""""""""""""""
.. toctree::
:maxdepth: 2
tutorials/svo_elk/srvo3

View File

@ -0,0 +1,165 @@
import triqs.utility.mpi as mpi
from triqs.operators.util import *
from h5 import HDFArchive
from triqs_cthyb import *
from triqs.gf import *
from triqs_dft_tools.sumk_dft import *
from triqs_dft_tools.converters.elk import *
dft_filename='SrVO3'
beta = 40
loops = 2 # Number of DMFT sc-loops
sigma_mix = 1.0 # Mixing factor of Sigma after solution of the AIM
use_blocks = True # use bloc structure from DFT input
prec_mu = 0.0001
h_field = 0.0
# Solver parameters
p = {}
p["max_time"] = -1
p["length_cycle"] = 200
p["n_warmup_cycles"] = 10000
p["n_cycles"] = 1000000
p["perform_tail_fit"] = True
p["fit_max_moment"] = 4
p["fit_min_n"] = 30
p["fit_max_n"] = 60
# If conversion step was not done, we could do it here. Uncomment the lines it you want to do this.
Converter = ElkConverter(filename=dft_filename, repacking=True)
Converter.convert_dft_input()
mpi.barrier()
previous_runs = 0
previous_present = False
if mpi.is_master_node():
with HDFArchive(dft_filename+'.h5','a') as f:
if 'dmft_output' in f:
ar = f['dmft_output']
if 'iterations' in ar:
previous_present = True
previous_runs = ar['iterations']
else:
f.create_group('dmft_output')
previous_runs = mpi.bcast(previous_runs)
previous_present = mpi.bcast(previous_present)
SK=SumkDFT(hdf_file=dft_filename+'.h5',use_dft_blocks=use_blocks,h_field=h_field)
n_orb = SK.corr_shells[0]['dim']
l = SK.corr_shells[0]['l']
spin_names = ["up","down"]
orb_names = [i for i in range(n_orb)]
## KANAMORI DENSITY-DENSITY (for full Kanamori use h_int_kanamori)
# Define interaction paramters, DC and Hamiltonian
U = 4.0
J = 0.65
dc_type = 1 # DC type: 0 FLL, 1 Held, 2 AMF
# Construct U matrix for density-density calculations
Umat, Upmat = U_matrix_kanamori(n_orb=n_orb, U_int=U, J_hund=J)
# Construct density-density Hamiltonian
h_int = h_int_density(spin_names, orb_names, map_operator_structure=SK.sumk_to_solver[0], U=Umat, Uprime=Upmat)
## SLATER HAMILTONIAN
## Define interaction paramters, DC and Hamiltonian
#U = 9.6
#J = 0.8
#dc_type = 0 # DC type: 0 FLL, 1 Held, 2 AMF
## Construct Slater U matrix
#U_sph = U_matrix(l=2, U_int=U, J_hund=J)
#U_cubic = transform_U_matrix(U_sph, spherical_to_cubic(l=2, convention='wien2k'))
#Umat = t2g_submatrix(U_cubic, convention='wien2k')
## Construct Slater Hamiltonian
#h_int = h_int_slater(spin_names, orb_names, map_operator_structure=SK.sumk_to_solver[0], U_matrix=Umat)
# Use GF structure determined by DFT blocks
gf_struct = [(block, indices) for block, indices in SK.gf_struct_solver[0].items()]
# Construct Solver
S = Solver(beta=beta, gf_struct=gf_struct)
if previous_present:
chemical_potential = 0
dc_imp = 0
dc_energ = 0
if mpi.is_master_node():
with HDFArchive(dft_filename+'.h5','r') as ar:
S.Sigma_iw << ar['dmft_output']['Sigma_iw']
chemical_potential,dc_imp,dc_energ = SK.load(['chemical_potential','dc_imp','dc_energ'])
S.Sigma_iw << mpi.bcast(S.Sigma_iw)
chemical_potential = mpi.bcast(chemical_potential)
dc_imp = mpi.bcast(dc_imp)
dc_energ = mpi.bcast(dc_energ)
SK.set_mu(chemical_potential)
SK.set_dc(dc_imp,dc_energ)
for iteration_number in range(1,loops+1):
if mpi.is_master_node(): print("Iteration = ", iteration_number)
SK.symm_deg_gf(S.Sigma_iw,ish=0) # symmetrise Sigma
SK.set_Sigma([ S.Sigma_iw ]) # set Sigma into the SumK class
chemical_potential = SK.calc_mu( precision = prec_mu ) # find the chemical potential for given density
S.G_iw << SK.extract_G_loc()[0] # calc the local Green function
mpi.report("Total charge of Gloc : %.6f"%S.G_iw.total_density())
# Init the DC term and the real part of Sigma, if no previous runs found:
if (iteration_number==1 and previous_present==False):
dm = S.G_iw.density()
SK.calc_dc(dm, U_interact = U, J_hund = J, orb = 0, use_dc_formula = dc_type)
S.Sigma_iw << SK.dc_imp[0]['up'][0,0]
# Calculate new G0_iw to input into the solver:
S.G0_iw << inverse(S.Sigma_iw + inverse(S.G_iw))
# Solve the impurity problem:
S.solve(h_int=h_int, **p)
# Solved. Now do post-processing:
mpi.report("Total charge of impurity problem : %.6f"%S.G_iw.total_density())
# Now mix Sigma and G with factor sigma_mix, if wanted:
if (iteration_number>1 or previous_present):
if mpi.is_master_node():
with HDFArchive(dft_filename+'.h5','r') as ar:
mpi.report("Mixing Sigma and G with factor %s"%sigma_mix)
S.Sigma_iw << sigma_mix * S.Sigma_iw + (1.0-sigma_mix) * ar['dmft_output']['Sigma_iw']
S.G_iw << sigma_mix * S.G_iw + (1.0-sigma_mix) * ar['dmft_output']['G_iw']
S.G_iw << mpi.bcast(S.G_iw)
S.Sigma_iw << mpi.bcast(S.Sigma_iw)
# Write the final Sigma and G to the hdf5 archive:
if mpi.is_master_node():
with HDFArchive(dft_filename+'.h5','a') as ar:
ar['dmft_output']['iterations'] = iteration_number + previous_runs
ar['dmft_output']['G_tau'] = S.G_tau
ar['dmft_output']['G_iw'] = S.G_iw
ar['dmft_output']['Sigma_iw'] = S.Sigma_iw
ar['dmft_output']['G0-%s'%(iteration_number)] = S.G0_iw
ar['dmft_output']['G-%s'%(iteration_number)] = S.G_iw
ar['dmft_output']['Sigma-%s'%(iteration_number)] = S.Sigma_iw
# Set the new double counting:
dm = S.G_iw.density() # compute the density matrix of the impurity problem
SK.calc_dc(dm, U_interact = U, J_hund = J, orb = 0, use_dc_formula = dc_type)
# Save stuff into the user_data group of hdf5 archive in case of rerun:
SK.save(['chemical_potential','dc_imp','dc_energ'])
#For FCSC calculations
#output the density matrix for Elk interface
dN, d = SK.calc_density_correction(dm_type='elk')
#correlation energy via the Migdal formula
correnerg = 0.5 * (S.G_iw * S.Sigma_iw).total_density()
#subtract the double counting energy
correnerg -= SK.dc_energ[0]
#convert to Hartree
correnerg = correnerg/SK.energy_unit
#save the correction to energy
if (mpi.is_master_node()):
f=open('DMATDMFT.OUT','a')
f.write("%.16f\n"%correnerg)
f.close()

View File

@ -0,0 +1,41 @@
!Calculates the V t2g Wannier projectors, Wannier charge and Wannier DOS of SrVO3
!Example by Alyn D. N. James
tasks
0
805
ngridk
12 12 12
sppath
'../../../species/'
rgkmax
7.0
avec
7.260500000 0.000000000 0.000000000
0.000000000 7.260500000 0.000000000
0.000000000 0.000000000 7.260500000
atoms
3 : nspecies
'Sr.in' : spfname
1 : natoms; atposl, bfcmt below
0.50000000 0.50000000 0.50000000 0.00000000 0.00000000 0.00000000
'V.in' : spfname
1 : natoms; atposl, bfcmt below
0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000
'O.in' : spfname
3 : natoms; atposl, bfcmt below
0.50000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000
0.00000000 0.50000000 0.00000000 0.00000000 0.00000000 0.00000000
0.00000000 0.00000000 0.50000000 0.00000000 0.00000000 0.00000000
wanproj !projector flag
1 !number of projectors - next 3 lines are repeated for each projector
2 2 3 !species, l, reduced max lm (rlmmax) value
7 8 9 !the lm quanties which will be projected (vector length eq. rlmmax)
-0.055 0.07 ![-1.5, 1.9] eV t2g correlated energy window

View File

@ -0,0 +1,81 @@
#!/bin/bash
#(Crude) shell script for FCSC calculations using the Elk-TRIQS setup.
#You may put job scheduler (PBS, Slurm or other) information here
#Note mpirun command lines may have to be altered for the
#scheduler used
#
#the Elk executable (may have to update path and version used)
export elk_ex="${HOME}/elk-6.2.8/src/elk"
#this variable is already linked in the $PATH in .bashrc
export triqs_ex="python"
#initial variables which can be tweeked
#max loop index - Input variable
export imax=20
#python file prefix - user's script
export triqs_name="dft_dmft_cthyb_elk"
#DFT+DMFT self-consistent cycle shell output file
export out_file="FCSC.OUT"
#elk interface tasks
export e2t_task=805
export t2e_task=808
#Master input file for the dft interface calculation.
export elk_master_file="elk_master.in"
#input elk file
export elk_infile="elk.in"
#output elk file
export elk_outfile="elk.out"
#output triqs file
export triqs_outfile="SC_DMFT.OUT"
#this variable will be used to replace the string TASK in elk_master.in
export task="TASK"
#check if master file exists
if [ ! -e "$elk_master_file" ]; then
echo "No master input file" > $out_file
exit
fi
echo " "> $elk_outfile
echo " "> $triqs_outfile
echo "Maximum number of iterations = "$imax > $out_file
echo "Number of processors used = "$NUMPROC >> $out_file
for (( i=1; i<=$imax; i++)); do
echo "SC loop "$i" of "$imax >> $out_file
echo " ">> $out_file
#copy master input to elk.in
cp $elk_master_file $elk_infile
#replace TASK string to interface task
sed -i "s/$task*/$e2t_task/" $elk_infile
#executes elk (generate projectors)
echo "SC loop "$i" of "$imax >> $elk_outfile
mpirun $elk_ex >> $elk_outfile
echo " ">> $elk_outfile
echo "Interfaced Elk to TRIQS via task "$e2t_task >> $out_file
#executes triqs
echo "SC loop "$i" of "$imax >> $triqs_outfile
mpirun $triqs_ex $triqs_name".py" >> $triqs_outfile
echo " " >> $triqs_outfile
echo "TRIQS DMFT loop(s) done " >> $out_file
#copy master input to elk.in
cp $elk_master_file $elk_infile
#replace TASK string to interface task
sed -i "s/$task*/$t2e_task/" $elk_infile
#executes elk (density update)
mpirun $elk_ex >> $elk_outfile
echo " ">> $elk_outfile
echo "Interfaced TRIQS dmft outputs into elk via task "$t2e_task >> $out_file
echo " ">> $out_file
done
#end

View File

@ -0,0 +1,40 @@
!Calculates the V t2g Wannier projectors, Wannier charge and Wannier DOS of SrVO3
!Example by Alyn D. N. James
tasks
TASK
ngridk
12 12 12
sppath
'../../../species/'
rgkmax
7.0
avec
7.260500000 0.000000000 0.000000000
0.000000000 7.260500000 0.000000000
0.000000000 0.000000000 7.260500000
atoms
3 : nspecies
'Sr.in' : spfname
1 : natoms; atposl, bfcmt below
0.50000000 0.50000000 0.50000000 0.00000000 0.00000000 0.00000000
'V.in' : spfname
1 : natoms; atposl, bfcmt below
0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000
'O.in' : spfname
3 : natoms; atposl, bfcmt below
0.50000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000
0.00000000 0.50000000 0.00000000 0.00000000 0.00000000 0.00000000
0.00000000 0.00000000 0.50000000 0.00000000 0.00000000 0.00000000
wanproj !projector flag
1 !number of projectors - next 3 lines are repeated for each projector
2 2 3 !species, l, reduced max lm (rlmmax) value
7 8 9 !the lm quanties which will be projected (vector length eq. rlmmax)
-0.055 0.07 ![-1.5, 1.9] eV t2g correlated energy window

View File

@ -0,0 +1,239 @@
.. _SrVO3_elk:
This example is almost identical to the :ref:`Wien2k-TRIQS SrVO3 example <SrVO3>`. On the example of SrVO3 we will discuss now how to set up a full working calculation using Elk, including the initialization of the :ref:`CTHYB solver <triqscthyb:welcome>`. Some additional parameter are introduced to make the calculation more efficient. This is a more advanced example, which is also suited for parallel execution.
For the convenience of the user, we provide also a full python script (:download:`dft_dmft_cthyb_elk.py <dft_dmft_cthyb_elk.py>`). The user has to adapt it to their own needs. How to execute your script is described :ref:`here<runpy>`.
For more details we refer to the :ref:`documentation <conversion>`, now we will discuss the conversion for Elk.
A brief note before discussing the example. This interface works for any type of ground state Elk calculation using the interface calls described in this example (i.e. the interface is universal). If the user wishes to perform a spin-polarized calculation in DMFT alone (non magnetic DFT inputs), they have to lift the up / down spin symmetry manually (not shown here).
Elk to TRIQS
============
First, we perform a DFT calculation, using the Elk package. As main input file we have to provide the so-called elk.in :file:`elk.in`. We use the following:
.. literalinclude:: elk.in
This :download:`elk.in` will generate the ground state (task 0) and the Wannier projectors (task 805) in a small energy window for the :math:`V` :math:`t_{2g}` orbitals. The elk executable is run in the directory including the elk.in file.
A simple python script that initializes the converter is::
from triqs_dft_tools.converters.elk import *
Converter = elkConverter(filename = "SrVO3")
After initializing the converter, we can now convert the input text files into an hdf5 archive by::
Converter.convert_dft_input()
This reads all necessary data from the :ref:`Elk output <Elk_files>`, and stores the converted input for the DMFT calculation in the file :file:`SrVO3.h5`.
The DMFT calculation
====================
The DMFT script itself is, except very few details, independent of the DFT package that was used to calculate the local orbitals. As soon as one has converted everything to the hdf5 format, the following procedure is practically the same.
Loading modules
---------------
First, we load the necessary modules::
from triqs_dft_tools.sumk_dft import *
from triqs.gf import *
from h5 import HDFArchive
from triqs.operators.util import *
from triqs_cthyb import *
import triqs.utility.mpi as mpi
The last two lines load the modules for the construction of the
:ref:`CTHYB solver <triqscthyb:welcome>`.
Initializing SumkDFT
--------------------
We define some parameters, which should be self-explanatory::
dft_filename = 'SrVO3' # filename
U = 4.0 # interaction parameters
J = 0.65
beta = 40 # inverse temperature
loops = 15 # number of DMFT loops
mix = 0.8 # mixing factor of Sigma after solution of the AIM
dc_type = 1 # DC type: 0 FLL, 1 Held, 2 AMF
use_blocks = True # use bloc structure from DFT input
prec_mu = 0.0001 # precision of chemical potential
And next, we can initialize the :class:`SumkDFT <dft.sumk_dft.SumkDFT>` class::
SK = SumkDFT(hdf_file=dft_filename+'.h5',use_dft_blocks=use_blocks)
Initializing the solver
-----------------------
We also have to specify the :ref:`CTHYB solver <triqscthyb:welcome>` related settings. We assume that the DMFT script for SrVO3 is executed on 16 cores. A sufficient set of parameters for a first guess is::
p = {}
# solver
p["length_cycle"] = 200
p["n_warmup_cycles"] = 100000
p["n_cycles"] = 1000000
# tail fit
p["perform_tail_fit"] = True
p["fit_max_moment"] = 4
p["fit_min_n"] = 30
p["fit_max_n"] = 60
Here we use a tail fit to deal with numerical noise of higher Matsubara frequencies. For other options and more details on the solver parameters, we refer to :ref:`CTHYB solver <triqscthyb:welcome>` documentation. It is important to note that the solver parameters have to be adjusted for each material individually. A guide on how to set the tail fit parameters is given :ref:`below <tailfit>`.
The next step is to initialize the :class:`solver class <triqs_cthyb.Solver>`. It consist of two parts:
#. Calculating the multi-band interaction matrix, and constructing the
interaction Hamiltonian.
#. Initializing the solver class itself.
The first step is done using methods of the :ref:`TRIQS <triqslibs:welcome>` library::
n_orb = SK.corr_shells[0]['dim']
l = SK.corr_shells[0]['l']
spin_names = ["up","down"]
orb_names = [i for i in range(n_orb)]
# Use GF structure determined by DFT blocks:
gf_struct = [(block, indices) for block, indices in SK.gf_struct_solver[0].iteritems()]
# Construct U matrix for density-density calculations:
Umat, Upmat = U_matrix_kanamori(n_orb=n_orb, U_int=U, J_hund=J)
We assumed here that we want to use an interaction matrix with Kanamori definitions of :math:`U` and :math:`J`.
Next, we construct the Hamiltonian and the solver::
h_int = h_int_density(spin_names, orb_names, map_operator_structure=SK.sumk_to_solver[0], U=Umat, Uprime=Upmat)
S = Solver(beta=beta, gf_struct=gf_struct)
For simplicity, we take only density-density interactions into account here. Other Hamiltonians with, e.g. with full rotational invariant interactions are:
* h_int_kanamori
* h_int_slater
For other choices of the interaction matrices (e.g Slater representation) or Hamiltonians, we refer to the reference manual of the :ref:`TRIQS <triqslibs:welcome>` library.
As a last step, we initialize the subgroup in the hdf5 archive to store the results::
if mpi.is_master_node():
with HDFArchive(dft_filename+'.h5') as ar:
if (not ar.is_group('dmft_output')):
ar.create_group('dmft_output')
DMFT cycle
----------
Now we can go to the definition of the self-consistency step. It consists again of the basic steps with some additional refinements::
for iteration_number in range(1,loops+1):
if mpi.is_master_node(): print "Iteration = ", iteration_number
SK.symm_deg_gf(S.Sigma_iw,ish=0) # symmetrizing Sigma
SK.set_Sigma([ S.Sigma_iw ]) # put Sigma into the SumK class
chemical_potential = SK.calc_mu( precision = prec_mu ) # find the chemical potential for given density
S.G_iw << SK.extract_G_loc()[0] # calc the local Green function
mpi.report("Total charge of Gloc : %.6f"%S.G_iw.total_density())
# In the first loop, init the DC term and the real part of Sigma:
if (iteration_number==1):
dm = S.G_iw.density()
SK.calc_dc(dm, U_interact = U, J_hund = J, orb = 0, use_dc_formula = dc_type)
S.Sigma_iw << SK.dc_imp[0]['up'][0,0]
# Calculate new G0_iw to input into the solver:
S.G0_iw << S.Sigma_iw + inverse(S.G_iw)
S.G0_iw << inverse(S.G0_iw)
# Solve the impurity problem:
S.solve(h_int=h_int, **p)
# Solved. Now do post-solution stuff:
mpi.report("Total charge of impurity problem : %.6f"%S.G_iw.total_density())
# Now mix Sigma and G with factor mix, if wanted:
if (iteration_number>1):
if mpi.is_master_node():
with HDFArchive(dft_filename+'.h5','r') as ar:
mpi.report("Mixing Sigma and G with factor %s"%mix)
S.Sigma_iw << mix * S.Sigma_iw + (1.0-mix) * ar['dmft_output']['Sigma_iw']
S.G_iw << mix * S.G_iw + (1.0-mix) * ar['dmft_output']['G_iw']
S.G_iw << mpi.bcast(S.G_iw)
S.Sigma_iw << mpi.bcast(S.Sigma_iw)
# Write the final Sigma and G to the hdf5 archive:
if mpi.is_master_node():
with HDFArchive(dft_filename+'.h5') as ar:
ar['dmft_output']['iterations'] = iteration_number
ar['dmft_output']['G_0'] = S.G0_iw
ar['dmft_output']['G_tau'] = S.G_tau
ar['dmft_output']['G_iw'] = S.G_iw
ar['dmft_output']['Sigma_iw'] = S.Sigma_iw
# Set the new double counting:
dm = S.G_iw.density() # compute the density matrix of the impurity problem
SK.calc_dc(dm, U_interact = U, J_hund = J, orb = 0, use_dc_formula = dc_type)
# Save stuff into the user_data group of hdf5 archive in case of rerun:
SK.save(['chemical_potential','dc_imp','dc_energ'])
TRIQS to Elk (Fully Charge Self-Consistent DFT+DMFT)
====================================================
To output the DMATDMFT.OUT file for a fully charge self-consistent calculation, add the following lines to the end of the DMFT python script::
#output the density matrix for Elk interface
dN, d = SK.calc_density_correction()
#correlation energy via the Migdal formula
correnerg = 0.5 * (S.G_iw * S.Sigma_iw).total_density()
#subtract the double counting energy
correnerg -= SK.dc_energ[0]
#convert to Hartree
correnerg = correnerg/SK.energy_unit
#save the correction to energy
if (mpi.is_master_node()):
f=open('DMATDMFT.OUT','a')
f.write("%.16f\n"%correnerg)
f.close()
To update the electron density and solve the Kohn-Sham equations once, run task 808 in elk.in. Automating this cycle can be done by running the shell script (:download:`elk_fcsc.sh <elk_fcsc.sh>`) and having an :download:`elk_master.in` file which replaces the tasks in elk.in for each new task in the FCSC DFT+DMFT cycle (see :download:`elk_master.in <elk_master.in>`. Assuming that the ground state has been calculated, this shell script executes the following:
#. generate the projectors (task 805)
#. execute the DMFT cycle(s)
#. update the electron density
#. -> (1) ...
The user just needs to specify the maximum number of FCSC cycles, as well as the number of OpenMP threads for Elk (`OMP_NUM_THREADS`) and the number of MPI ranks in the bash script.
This is all we need for the one-shot or FCSC DFT+DMFT calculation. All results of this calculation will be stored in a separate subgroup in the hdf5 file, called `dmft_output`. Note that the script performs 15 DMFT cycles, but does not check for convergence. It would be possible to build in convergence criteria. A simple check for convergence can be also done if you store multiple quantities of each iteration and analyse the convergence manually. In general, it is advisable to start with less good statistics (fewer measurements), and increase the number of measurements close to convergence (e.g. after a few initial iterations). This helps to keep computational costs low during the first iterations.
Using the Kanamori Hamiltonian and the parameters above (but on 16 cores), your self energy after the **first iteration** should look something like:
.. image:: SrVO3_Sigma_iw_it1.png
:width: 700
:align: center
.. _tailfit:
Tail fit parameters
-------------------
A good way to identify suitable tail fit parameters is by "human inspection". Therefore disabled the tail fitting first::
p["perform_tail_fit"] = False
and perform only one DMFT iteration. The resulting self energy can be tail fitted by hand::
Sigma_iw_fit = S.Sigma_iw.copy()
Sigma_iw_fit << tail_fit(S.Sigma_iw, fit_max_moment = 4, fit_min_n = 40, fit_max_n = 160)[0]
Plot the self energy and adjust the tail fit parameters such that you obtain a proper fit. The :meth:`fit_tail function <triqs.gf.tools.tail_fit>` is part of the :ref:`TRIQS <triqslibs:welcome>` library.
For a self energy which is going to zero for :math:`i\omega \rightarrow 0` our suggestion is to start the tail fit (:emphasis:`fit_min_n`) at a Matsubara frequency considerable above the minimum of the self energy and to stop (:emphasis:`fit_max_n`) before the noise fully takes over. If it is difficult to find a reasonable fit in this region you should increase your statistics (number of measurements). Keep in mind that :emphasis:`fit_min_n` and :emphasis:`fit_max_n` also depend on :math:`\beta`.

View File

@ -24,6 +24,7 @@ from .wien2k import Wien2kConverter
from .hk import HkConverter
from .vasp import VaspConverter
from .wannier90 import Wannier90Converter
from .elk import ElkConverter
__all__ =['Wien2kConverter','HkConverter','Wannier90Converter','VaspConverter']
__all__ =['Wien2kConverter','HkConverter','Wannier90Converter','VaspConverter','ElkConverter']

View File

@ -0,0 +1,640 @@
##########################################################################
#
# TRIQS: a Toolbox for Research in Interacting Quantum Systems
#
# Copyright (C) 2019 by A. D. N. James, A. Hampel and M. Aichhorn
#
# TRIQS is free software: you can redistribute it and/or modify it under the
# terms of the GNU General Public License as published by the Free Software
# Foundation, either version 3 of the License, or (at your option) any later
# version.
#
# TRIQS is distributed in the hope that it will be useful, but WITHOUT ANY
# WARRANTY; without even the implied warranty of MERCHANTABILITY or FITNESS
# FOR A PARTICULAR PURPOSE. See the GNU General Public License for more
# details.
#
# You should have received a copy of the GNU General Public License along with
# TRIQS. If not, see <http://www.gnu.org/licenses/>.
#
##########################################################################
from types import *
import numpy
from .converter_tools import *
import os.path
from h5 import *
from locale import atof
from triqs_dft_tools.converters.elktools import readElkfiles as read_Elk
from triqs_dft_tools.converters.elktools import ElkConverterTools as Elk_tools
class ElkConverter(ConverterTools,Elk_tools,read_Elk):
"""
Conversion from Elk output to an hdf5 file that can be used as input for the SumkDFT class.
"""
def __init__(self, filename, hdf_filename=None,
dft_subgrp='dft_input', symmcorr_subgrp='dft_symmcorr_input',
bc_subgrp='dft_bandchar_input', symmpar_subgrp='dft_symmpar_input',
bands_subgrp='dft_bands_input', misc_subgrp='dft_misc_input',
transp_subgrp='dft_transp_input',fs_subgrp='dft_fs_input',
repacking=False):
"""
Initialise the class.
Parameters
----------
filename : string
Base name of DFT files.
hdf_filename : string, optional
Name of hdf5 archive to be created.
dft_subgrp : string, optional
Name of subgroup storing necessary DFT data.
symmcorr_subgrp : string, optional
Name of subgroup storing correlated-shell symmetry data.
parproj_subgrp : string, optional
Name of subgroup storing partial projector data.
symmpar_subgrp : string, optional
Name of subgroup storing partial-projector symmetry data.
bands_subgrp : string, optional
Name of subgroup storing band data.
misc_subgrp : string, optional
Name of subgroup storing miscellaneous DFT data.
transp_subgrp : string, optional
Name of subgroup storing transport data.
repacking : boolean, optional
Does the hdf5 archive need to be repacked to save space?
"""
assert isinstance(filename, str), "ElkConverter: Please provide the DFT files' base name as a string."
if hdf_filename is None:
hdf_filename = filename + '.h5'
self.hdf_file = hdf_filename
self.dft_file = 'PROJ.OUT'
self.band_file = 'BAND.OUT'
self.eval_file = 'EIGVAL.OUT'
self.efermi_file = 'EFERMI.OUT'
self.kp_file = 'KPOINTS.OUT'
self.geom_file='GEOMETRY.OUT'
self.dft_subgrp = dft_subgrp
self.symmcorr_subgrp = symmcorr_subgrp
self.bc_subgrp = bc_subgrp
self.symmpar_subgrp = symmpar_subgrp
self.bands_subgrp = bands_subgrp
self.misc_subgrp = misc_subgrp
self.transp_subgrp = transp_subgrp
self.fs_subgrp = fs_subgrp
self.fortran_to_replace = {'D': 'E'}
# Checks if h5 file is there and repacks it if wanted:
if (os.path.exists(self.hdf_file) and repacking):
ConverterTools.repack(self)
def check_dens(self,n_k,nstsv,occ,bz_weights,n_spin_blocs,band_window,SO):
"""
Check the charge density below the correlated energy window and up to the Fermi level
"""
density_required=0.0E-7
charge_below=0.0E-7
#calculate the valence charge and charge below lower energy window bound
#Elk does not use the tetrahedron method when calculating these charges
for ik in range(n_k):
for ist in range(nstsv):
#calculate the charge over all the bands
density_required+=occ[ik][ist]*bz_weights[ik]
for isp in range(n_spin_blocs):
#Convert occ list from elk to two index format for spins
jst=int((isp)*nstsv*0.5)
#Take lowest index in band_window for SO system
if(SO==0):
nst=band_window[isp][ik, 0]-1
else:
band=[band_window[0][ik, 0],band_window[1][ik, 0]]
nst=min(band)-1
#calculate the charge below energy window
for ist in range(jst,nst):
charge_below+=occ[ik][ist]*bz_weights[ik]
#return charges
return(density_required,charge_below)
def rotsym(self,n_shells,shells,n_symm,ind,basis,T,mat):
"""
Rotates the symmetry matrices into basis defined by the T unitary matrix
the outputted projectors are rotated to the irreducible representation
and then reduced in size to the orbitals used to construct the projectors.
"""
for ish in range(n_shells):
#check that the T matrix is not the Identity (i.e. not using spherical
#harmonics).
if(basis[ish]!=0):
#put mat into temporary matrix
temp=mat
#index range of lm values used to create the Wannier projectors
min_ind=numpy.min(ind[ish][:])
max_ind=numpy.max(ind[ish][:])+1
#dimension of lm values used to construct the projectors
dim=shells[ish]['dim']
#loop over all symmetries
for isym in range(n_symm):
#rotate symmetry matrix into basis defined by T
mat[isym][ish]=numpy.matmul(T[ish],mat[isym][ish])
mat[isym][ish]=numpy.matmul(mat[isym][ish],T[ish].transpose())
#put desired subset of transformed symmetry matrix into temp matrix for symmetry isym
for id in range(len(ind[ish])):
i=ind[ish][id]
for jd in range(len(ind[ish][:])):
j=ind[ish][jd]
temp[isym][ish][id,jd]=mat[isym][ish][i,j]
#put temp matrix into mat
mat=temp
#reduce size of lm arrays in mat lm dim
for isym in range(n_symm):
dim=shells[ish]['dim']
mat[isym][ish]=mat[isym][ish][:dim,:dim]
return mat
def update_so_quatities(self,n_shells,shells,n_corr_shells,corr_shells,n_inequiv_shells,dim_reps,n_k,n_symm,n_orbitals,proj_mat,T,su2,mat,sym=True):
"""
Changes the array sizes and elements for arrays used in spin-orbit coupled calculations.
"""
#change dim for each shell
for ish in range(n_shells):
shells[ish]['dim'] = 2*shells[ish]['dim']
for ish in range(n_corr_shells):
corr_shells[ish]['dim'] = 2*corr_shells[ish]['dim']
for ish in range(n_inequiv_shells):
dim_reps[ish]=[2*dim_reps[ish][i] for i in range(len(dim_reps[ish]))]
#Make temporary array of original n_orbitals
n_orbitals_orig=n_orbitals
#Make SO n_orbitals array
#loop over k-points
for ik in range(n_k):
#new orbital array
n_orbitals[ik,0]=max(n_orbitals[ik,:])
#reduce array size
n_orbitals=n_orbitals[:,:1]
#Resize proj_mat, mat, T
#make temporary projector array
proj_mat_tmp = numpy.zeros([n_k, 1, n_corr_shells, max([crsh['dim'] for crsh in corr_shells]), numpy.max(n_orbitals)], numpy.complex_)
for ish in range(n_corr_shells):
#update proj_mat
for ik in range(n_k):
#extra array elements in "dim" dimension
size=int(0.5*corr_shells[ish]['dim'])
#put each spinor into tmp array and ensure elements are assigned correctly in case of change of max(n_orbitals)
proj_mat_tmp[ik][0][ish][0:size][0:n_orbitals_orig[ik,0]]=proj_mat[ik][0][ish][0:size][0:n_orbitals_orig[ik,0]]
#put other spinor projectors into extra "dim" elements
proj_mat_tmp[ik][0][ish][size:2*size][0:n_orbitals_orig[ik,1]]=proj_mat[ik][1][ish][0:size][0:n_orbitals_orig[ik,1]]
#update T
#extra array elements in each dimension
size=2*corr_shells[ish]['l']+1
#extend the arrays
T[ish]=numpy.lib.pad(T[ish],((0,size),(0,size)),'constant',constant_values=(0.0))
#make block diagonal
T[ish][size:2*size,size:2*size]=T[ish][0:size,0:size]
#update the symmetries arrays if needed
if(sym):
#update mat - This includes the spin SU(2) matrix for spin-coupled calculations
#size of each quadrant in the lm symmetry array.
size=int(0.5*corr_shells[ish]['dim'])
#temporary spin block array for SU(2) spin operations on mat
spinmat = numpy.zeros([size,2,size,2],numpy.complex_)
for isym in range(n_symm):
#expand size of array
mat[isym][ish]=numpy.lib.pad(mat[isym][ish],((0,size),(0,size)),'constant',constant_values=(0.0))
#make arraye block diagonal
mat[isym][ish][size:2*size,size:2*size]=mat[isym][ish][0:size,0:size]
#apply SU(2) spin matrices to lm symmetries
#put mat into array of spin blocks
for i1,i2 in numpy.ndindex(2,2):
spinmat[0:size,i1,0:size,i2] = mat[isym][ish][i1*size:(i1+1)*size,i2*size:(i2+1)*size]
#apply the SU(2) spin matrices
for ilm,jlm in numpy.ndindex(size,size):
spinmat[ilm,:,jlm,:] = numpy.dot(su2[isym][:,:],spinmat[ilm,:,jlm,:])
#put spinmat into back in mat format
for i1,i2 in numpy.ndindex(2,2):
mat[isym][ish][i1*size:(i1+1)*size,i2*size:(i2+1)*size] = spinmat[0:size,i1,0:size,i2]
#assign arrays and delete temporary arrays
del proj_mat
proj_mat = proj_mat_tmp
del proj_mat_tmp, n_orbitals_orig
return shells,corr_shells,dim_reps,n_orbitals,proj_mat,T,mat
def sort_dft_eigvalues(self,n_spin_blocs,SO,n_k,n_orbitals,band_window,en,energy_unit):
"""
Rearranges the energy eigenvalue arrays into TRIQS format
"""
hopping = numpy.zeros([n_k, n_spin_blocs, numpy.max(n_orbitals), numpy.max(n_orbitals)], numpy.complex_)
#loop over spin
for isp in range(n_spin_blocs):
#loop over k-points
for ik in range(n_k):
#loop over bands
for ist in range(0,n_orbitals[ik, isp]):
#converter index for spin polarised Elk indices and take SO into consideration
if(SO==0):
jst=int(band_window[isp][ik, 0]-1+ist)
else:
band=[band_window[0][ik, 0],band_window[1][ik, 0]]
jst=int(min(band)-1+ist)
#correlated window energies
hopping[ik,isp,ist,ist]=en[ik][jst]*energy_unit
return hopping
def convert_dft_input(self):
"""
Reads the appropriate files and stores the data for the
- dft_subgrp
- symmcorr_subgrp
- misc_subgrp
in the hdf5 archive.
"""
# Read and write only on the master node
if not (mpi.is_master_node()):
return
filext='.OUT'
dft_file='PROJ'+filext
mpi.report("Reading %s" % dft_file)
#Energy conversion - Elk uses Hartrees
energy_unit = 27.2113850560 # Elk uses hartrees
#The projectors change size per k-point
k_dep_projection = 1
#Symmetries are used
symm_op = 1 # Use symmetry groups for the k-sum
shells=[]
#read information about projectors calculated in the Elk calculation
[gen_info,n_corr_shells,n_inequiv_shells,corr_to_inequiv,inequiv_to_corr,corr_shells,n_reps,dim_reps,ind,basis,T] = read_Elk.read_proj(self,dft_file)
#get info for HDF5 file from gen_info
n_k=gen_info['n_k']
SP=gen_info['spinpol']-1
#Elk uses spinor wavefunctions. Therefore these two spinor wavefunctions have spin-orbit coupling incorporated in them. Here we read in the spinors
n_spin_blocs = SP + 1
SO=gen_info['SO']
n_atoms=gen_info['natm']
#Elk only calculates Wannier projectors (no theta projectors generated):
n_shells=n_corr_shells
for ish in range(n_shells):
shells.append(corr_shells[ish].copy())
#remove last 2 entries from corr_shlls
del shells[ish]['SO']
del shells[ish]['irep']
shells[ish]['dim'] = 2*shells[ish]['l']+1
#read eigenvalues calculated in the Elk calculation
mpi.report("Reading %s and EFERMI.OUT" % self.eval_file)
[en,occ,nstsv]=read_Elk.read_eig(self)
#read projectors calculated in the Elk calculation
proj_mat = numpy.zeros([n_k, n_spin_blocs, n_corr_shells, max([crsh['dim'] for crsh in corr_shells]), nstsv], numpy.complex_)
mpi.report("Reading projector(s)")
for ish in range(n_corr_shells):
[n_orbitals,band_window,rep,proj_mat]=read_Elk.read_projector(self,corr_shells,n_spin_blocs,ish,proj_mat,ind,T,basis,filext)
#read kpoints calculated in the Elk calculation
mpi.report("Reading %s" % self.kp_file)
[bz_weights,vkl]=read_Elk.read_kpoints(self)
#symmetry matrix
mpi.report("Reading GEOMETRY.OUT")
#read in atom posistions, the symmetry operators (in lattice coordinates) and lattice vectors
[ns, na, atpos]=read_Elk.read_geometry(self)
#Read symmetry files
mpi.report("Reading SYMCRYS.OUT")
[n_symm,spinmat,symmat,tr] = read_Elk.readsym(self)
mpi.report("Reading LATTICE.OUT")
[amat,amatinv,bmat,bmatinv] = read_Elk.readlat(self)
#calculating atom permutations
perm = Elk_tools.gen_perm(self,n_symm,ns,na,n_atoms,symmat,tr,atpos)
#determine the cartesian lattice symmetries and the spin axis rotations
#required for the spinors (for SO for now)
su2 = []
symmatc=[]
for isym in range(n_symm):
#convert the lattice symmetry matrices into cartesian coordinates
tmp = numpy.matmul(amat,symmat[isym])
symmatc.append(numpy.matmul(tmp,amatinv))
#convert the spin symmetry matrices into cartesian coordinates
spinmatc = numpy.matmul(amat,spinmat[isym])
spinmatc = numpy.matmul(spinmatc,amatinv)
#calculate the rotation angle and spin axis vector in cartesian coordinates
[v,th] = self.rotaxang(spinmatc[:,:])
#calculate the SU(2) matrix from the angle and spin axis vector
su2.append(self.axangsu2(v,th))
del tmp
#calculating the symmetries in complex harmonics
mat = Elk_tools.symlat_to_complex_harmonics(self,n_symm,n_corr_shells,symmatc,corr_shells)
mat = self.rotsym(n_corr_shells,corr_shells,n_symm,ind,basis,T,mat)
#The reading is done. Some variables may need to change for TRIQS compatibility.
#Alter size of some of the arrays if spin orbit coupling is enabled.
#For SO in Elk, the eigenvalues and eigenvector band indices are in asscending order w.r.t energy
if(SO==1):
[shells,corr_shells,dim_reps,n_orbitals,proj_mat,T,mat]=self.update_so_quatities(n_shells,shells,n_corr_shells,corr_shells,n_inequiv_shells,dim_reps,n_k,n_symm,n_orbitals,proj_mat,T,su2,mat)
#reduce n_spin_blocs
n_spin_blocs = SP + 1 - SO
#put the energy eigenvalues arrays in TRIQS format
hopping = self.sort_dft_eigvalues(n_spin_blocs,SO,n_k,n_orbitals,band_window,en,energy_unit)
#Elk does not use global to local matrix rotation (Rotloc) as is done in Wien2k. However, the projectors
#require a symmetry matrix to rotate from jatom to iatom. Below finds the non inversion
#symmetric matrices which were used in calculating the projectors
use_rotations = 1
rot_mat = [numpy.identity(corr_shells[icrsh]['dim'], numpy.complex_) for icrsh in range(n_corr_shells)]
for icrsh in range(n_corr_shells):
incrsh = corr_to_inequiv[icrsh]
iatom = corr_shells[incrsh]['atom']
for isym in range(n_symm):
jatom=perm[isym][corr_shells[icrsh]['atom']-1]
#determinant determines if crystal symmetry matrix has inversion symmetry (=-1)
det = numpy.linalg.det(symmat[isym][:,:])
if((jatom==iatom)&(det>0.0)):
rot_mat[icrsh][:,:]=mat[isym][icrsh][:,:]
#used first desired symmetry in crystal symmetry list
break
# Elk does not currently use time inversion symmetry
rot_mat_time_inv = [0 for i in range(n_corr_shells)]
#Check that the charge of all the bands and below the correlated window have been calculated correctly
[density_required, charge_below] = self.check_dens(n_k,nstsv,occ,bz_weights,n_spin_blocs,band_window,SO)
#calculate the required charge (density_required) to remain charge neutral
mpi.report("The total charge of the system = %f" %density_required)
mpi.report("The charge below the correlated window = %f" %charge_below)
mpi.report("The charge within the correlated window = %f" %(density_required - charge_below))
#Elk interface does not calculate theta projectors, hence orbits are the same as Wannier projectors
orbits=[]
#remove the spatom index to avoid errors in the symmetry routines
for ish in range(n_corr_shells):
#remove "spatom"
del corr_shells[ish]['spatom']
orbits.append(corr_shells[ish].copy())
for ish in range(n_shells):
#remove "spatom"
del shells[ish]['spatom']
n_orbits=len(orbits)
#Note that the T numpy array is defined for all shells.
# Save it to the HDF:
ar = HDFArchive(self.hdf_file, 'a')
if not (self.dft_subgrp in ar):
ar.create_group(self.dft_subgrp)
# The subgroup containing the data. If it does not exist, it is
# created. If it exists, the data is overwritten!
things_to_save = ['energy_unit', 'n_k', 'k_dep_projection', 'SP', 'SO', 'charge_below', 'density_required',
'symm_op', 'n_shells', 'shells', 'n_corr_shells', 'corr_shells', 'use_rotations', 'rot_mat',
'rot_mat_time_inv', 'n_reps', 'dim_reps', 'T', 'n_orbitals', 'proj_mat', 'bz_weights', 'hopping',
'n_inequiv_shells', 'corr_to_inequiv', 'inequiv_to_corr']
for it in things_to_save:
ar[self.dft_subgrp][it] = locals()[it]
del ar
# Save it to the HDF:
ar = HDFArchive(self.hdf_file, 'a')
symm_subgrp=self.symmcorr_subgrp
#Elk does not use time inversion symmetry
time_inv = [0 for j in range(n_symm)]
mat_tinv = [numpy.identity(orbits[orb]['dim'], numpy.complex_)
for orb in range(n_orbits)]
#Save all the symmetry data
if not (symm_subgrp in ar):
ar.create_group(symm_subgrp)
things_to_save_sym = ['n_symm', 'n_atoms', 'perm',
'orbits', 'SO', 'SP', 'time_inv', 'mat', 'mat_tinv']
for it in things_to_save_sym:
ar[symm_subgrp][it] = locals()[it]
del ar
#Save misc info
things_to_save_misc = ['band_window','vkl','nstsv']
# Save it to the HDF:
ar = HDFArchive(self.hdf_file, 'a')
if not (self.misc_subgrp in ar):
ar.create_group(self.misc_subgrp)
for it in things_to_save_misc:
ar[self.misc_subgrp][it] = locals()[it]
del ar
mpi.report('Converted the Elk ground state data')
def convert_bands_input(self):
"""
Reads the appropriate files and stores the data for the bands_subgrp in the hdf5 archive.
"""
# Read and write only on the master node
if not (mpi.is_master_node()):
return
filext='_WANBAND.OUT'
dft_file='PROJ'+filext
mpi.report("Reading %s" % dft_file)
#Energy conversion - Elk uses Hartrees
energy_unit = 27.2113850560 # Elk uses hartrees
shells=[]
#read information about projectors calculated in the Elk calculation
[gen_info,n_corr_shells,n_inequiv_shells,corr_to_inequiv,inequiv_to_corr,corr_shells,n_reps,dim_reps,ind,basis,T] = read_Elk.read_proj(self,dft_file)
#get info for HDF5 file from gen_info
n_k=gen_info['n_k']
SP=gen_info['spinpol']-1
#Elk uses spinor wavefunctions. Therefore these two spinor wavefunctions have spin-orbit coupling incorporated in them. Here we read in the spinors
n_spin_blocs = SP + 1
SO=gen_info['SO']
#Elk only calculates Wannier projectors (no theta projectors generated):
n_shells=n_corr_shells
for ish in range(n_shells):
shells.append(corr_shells[ish].copy())
#remove last 2 entries from corr_shlls
del shells[ish]['SO']
del shells[ish]['irep']
shells[ish]['dim'] = 2*shells[ish]['l']+1
#read in the band eigenvalues
mpi.report("Reading BAND.OUT")
en=numpy.loadtxt('BAND.OUT')
nstsv=int(len(en[:,1])/n_k)
#convert the en array into a workable format
entmp = numpy.zeros([n_k,nstsv], numpy.complex_)
enj=0
for ist in range(nstsv):
for ik in range(n_k):
entmp[ik,ist]=en[enj,1]
enj+=1
del en
#read projectors
proj_mat = numpy.zeros([n_k, n_spin_blocs, n_corr_shells, max([crsh['dim'] for crsh in corr_shells]), nstsv], numpy.complex_)
mpi.report("Reading projector(s)")
for ish in range(n_corr_shells):
[n_orbitals,band_window,rep,proj_mat]=read_Elk.read_projector(self,corr_shells,n_spin_blocs,ish,proj_mat,ind,T,basis,filext)
#alter arrays for spin-orbit coupling
if(SO==1):
mat=[]
su2=[]
n_symm=1
[shells,corr_shells,dim_reps,n_orbitals,proj_mat,T,mat]=self.update_so_quatities(n_shells,shells,n_corr_shells,corr_shells,n_inequiv_shells,dim_reps,n_k,n_symm,n_orbitals,proj_mat,T,su2,mat,sym=False)
#reduce n_spin_blocs
n_spin_blocs = SP + 1 - SO
#put the energy eigenvalues arrays in TRIQS format
hopping = self.sort_dft_eigvalues(n_spin_blocs,SO,n_k,n_orbitals,band_window,entmp,energy_unit)
# No partial projectors generate, set to 0:
n_parproj = numpy.array([0])
proj_mat_all = numpy.array([0])
# Save it to the HDF:
ar = HDFArchive(self.hdf_file, 'a')
if not (self.bands_subgrp in ar):
ar.create_group(self.bands_subgrp)
# The subgroup containing the data. If it does not exist, it is
# created. If it exists, the data is overwritten!
things_to_save = ['n_k', 'n_orbitals', 'proj_mat',
'hopping', 'n_parproj', 'proj_mat_all']
for it in things_to_save:
ar[self.bands_subgrp][it] = locals()[it]
del ar
mpi.report('Converted the band data')
def convert_fs_input(self):
"""
Reads the appropriate files and stores the data for the FS_subgrp in the hdf5 archive.
"""
# Read and write only on the master node
if not (mpi.is_master_node()):
return
filext='_FS.OUT'
dft_file='PROJ'+filext
mpi.report("Reading %s" % dft_file)
#Energy conversion - Elk uses Hartrees
energy_unit = 27.2113850560 # Elk uses hartrees
shells=[]
#read information about projectors calculated in the Elk calculation
[gen_info,n_corr_shells,n_inequiv_shells,corr_to_inequiv,inequiv_to_corr,corr_shells,n_reps,dim_reps,ind,basis,T] = read_Elk.read_proj(self,dft_file)
#get info for HDF5 file from gen_info
n_k=gen_info['n_k']
SP=gen_info['spinpol']-1
#Elk uses spinor wavefunctions. Therefore these two spinor wavefunctions have spin-orbit coupling incorporated in them. Here we read in the spinors
n_spin_blocs = SP + 1
SO=gen_info['SO']
#Elk only calculates Wannier projectors (no theta projectors generated):
n_shells=n_corr_shells
for ish in range(n_shells):
shells.append(corr_shells[ish].copy())
#remove last 2 entries from corr_shlls
del shells[ish]['SO']
del shells[ish]['irep']
shells[ish]['dim'] = 2*shells[ish]['l']+1
#read in the eigenvalues used for the FS calculation
mpi.report("Reading EIGVAL_FS.OUT and EFERMI.OUT")
[en,occ,nstsv]=read_Elk.read_eig(self,filext=filext)
#read kpoints calculated in the Elk FS calculation
mpi.report("Reading KPOINT_FS.OUT")
[bz_weights,vkl]=read_Elk.read_kpoints(self,filext=filext)
#read projectors
proj_mat = numpy.zeros([n_k, n_spin_blocs, n_corr_shells, max([crsh['dim'] for crsh in corr_shells]), nstsv], numpy.complex_)
mpi.report("Reading projector(s)")
for ish in range(n_corr_shells):
[n_orbitals,band_window,rep,proj_mat]=read_Elk.read_projector(self,corr_shells,n_spin_blocs,ish,proj_mat,ind,T,basis,filext)
#Need lattice symmetries to unfold the irreducible BZ
#Read symmetry files
mpi.report("Reading SYMCRYS.OUT")
[n_symm,spinmat,symlat,tr] = read_Elk.readsym(self)
mpi.report("Reading LATTICE.OUT")
[amat,amatinv,bmat,bmatinv] = read_Elk.readlat(self)
#Put eigenvalues into array of eigenvalues for the correlated window
#alter arrays for spin-orbit coupling
if(SO==1):
mat=[]
su2=[]
[shells,corr_shells,dim_reps,n_orbitals,proj_mat,T,mat]=self.update_so_quatities(n_shells,shells,n_corr_shells,corr_shells,n_inequiv_shells,dim_reps,n_k,n_symm,n_orbitals,proj_mat,T,su2,mat,sym=False)
#reduce n_spin_blocs
n_spin_blocs = SP + 1 - SO
#put the energy eigenvalues arrays in TRIQS format
hopping = self.sort_dft_eigvalues(n_spin_blocs,SO,n_k,n_orbitals,band_window,en,energy_unit)
# Save it to the HDF:
ar = HDFArchive(self.hdf_file, 'a')
if not (self.fs_subgrp in ar):
ar.create_group(self.fs_subgrp)
# The subgroup containing the data. If it does not exist, it is
# created. If it exists, the data is overwritten!
things_to_save = ['n_k', 'n_orbitals', 'proj_mat','bmat',
'hopping', 'vkl','symlat', 'n_symm']
for it in things_to_save:
ar[self.fs_subgrp][it] = locals()[it]
del ar
mpi.report('Converted the FS data')
def dft_band_characters(self):
"""
Reads in the band characters generated in Elk to be used for
PDOS and band character band structure plots.
"""
if not (mpi.is_master_node()):
return
mpi.report("Reading BC.OUT")
# get needed data from hdf file
# from general info
ar = HDFArchive(self.hdf_file, 'a')
things_to_read = ['SP', 'SO','n_k','n_orbitals']
for it in things_to_read:
if not hasattr(self, it):
setattr(self, it, ar[self.dft_subgrp][it])
#from misc info
things_to_read = ['nstsv','band_window']
for it in things_to_read:
if not hasattr(self, it):
setattr(self, it, ar[self.misc_subgrp][it])
#from sym info
things_to_read = ['n_atoms']
symm_subgrp=self.symmcorr_subgrp
for it in things_to_read:
if not hasattr(self, it):
setattr(self, it, ar[symm_subgrp][it])
#read in band characters
[bc,maxlm] = read_Elk.read_bc(self)
#set up SO bc array
if (self.SO):
tmp = numpy.zeros([2*maxlm,1,self.n_atoms,self.nstsv,self.n_k], numpy.float_)
#put both spinors into the lm array indices.
tmp[0:maxlm,0,:,:,:]=bc[0:maxlm,0,:,:,:]
tmp[maxlm:2*maxlm,0,:,:,:]=bc[0:maxlm,1,:,:,:]
maxlm=2*maxlm
del bc
bc = tmp
del tmp
#reduce bc matrix to band states stored in hdf file
n_spin_blocs=self.SP+1-self.SO
tmp = numpy.zeros([maxlm,n_spin_blocs,self.n_atoms,numpy.max(self.n_orbitals),self.n_k], numpy.float_)
for ik in range(self.n_k):
for isp in range(n_spin_blocs):
nst=self.n_orbitals[ik,isp]
ibot=self.band_window[isp][ik, 0]-1
itop=ibot+nst
tmp[:,isp,:,0:nst,ik]=bc[:,isp,:,ibot:itop,ik]
del bc
bc = tmp
del tmp
things_to_save = ['maxlm', 'bc']
if not (self.bc_subgrp in ar):
ar.create_group(self.bc_subgrp)
for it in things_to_save:
ar[self.bc_subgrp][it] = locals()[it]
del ar
mpi.report('Converted the band character data')

View File

@ -0,0 +1,27 @@
##########################################################################
#
# TRIQS: a Toolbox for Research in Interacting Quantum Systems
#
# Copyright (C) 2019 by A. D. N. James, A. Hampel and M. Aichhorn
#
# TRIQS is free software: you can redistribute it and/or modify it under the
# terms of the GNU General Public License as published by the Free Software
# Foundation, either version 3 of the License, or (at your option) any later
# version.
#
# TRIQS is distributed in the hope that it will be useful, but WITHOUT ANY
# WARRANTY; without even the implied warranty of MERCHANTABILITY or FITNESS
# FOR A PARTICULAR PURPOSE. See the GNU General Public License for more
# details.
#
# You should have received a copy of the GNU General Public License along with
# TRIQS. If not, see <http://www.gnu.org/licenses/>.
#
##########################################################################
from .readElkfiles import readElkfiles
from .elk_converter_tools import ElkConverterTools
__all__ =['readElkfiles','ElkConverterTools']

View File

@ -0,0 +1,296 @@
##########################################################################
#
# TRIQS: a Toolbox for Research in Interacting Quantum Systems
#
# Copyright (C) 2019 by A. D. N. James, M. Zingl and M. Aichhorn
#
# TRIQS is free software: you can redistribute it and/or modify it under the
# terms of the GNU General Public License as published by the Free Software
# Foundation, either version 3 of the License, or (at your option) any later
# version.
#
# TRIQS is distributed in the hope that it will be useful, but WITHOUT ANY
# WARRANTY; without even the implied warranty of MERCHANTABILITY or FITNESS
# FOR A PARTICULAR PURPOSE. See the GNU General Public License for more
# details.
#
# You should have received a copy of the GNU General Public License along with
# TRIQS. If not, see <http://www.gnu.org/licenses/>.
#
##########################################################################
from types import *
import numpy
import os.path
from locale import atof
class ElkConverterTools:
"""
Conversion Tools required to help covert Elk outputs into the TRIQS format.
"""
def __init__(self):
pass
def rotaxang(self,rot):
"""
This routine determines the axis of rotation vector (v) and the angle of rotation (th).
If R corresponds to an improper rotation then only the proper part is used and the determinant
is set to -1. The rotation convention follows the "right-hand rule". See Elk's rotaxang
routine.
"""
eps=1E-8
v=numpy.zeros([3], numpy.float_)
# find the determinant
det=numpy.linalg.det(rot)
if (abs(det-1.0)<eps):
det=1.0
elif (abs(det+1.0)<eps):
det=-1.0
else:
raise "sym_converter : Invalid rotation matrix!"
# proper rotation matrix
rotp=det*rot
v[0]=(rotp[1,2]-rotp[2,1])/2.0
v[1]=(rotp[2,0]-rotp[0,2])/2.0
v[2]=(rotp[0,1]-rotp[1,0])/2.0
t1=numpy.sqrt(numpy.dot(v,v))
t2=(rotp[0,0]+rotp[1,1]+rotp[2,2]-1.0)/2.0
if (abs(abs(t2)-1.0)>eps):
# theta not equal to 0 or pi
th=-numpy.arctan2(t1,t2)
v[:]=v[:]/t1
else:
# special case of sin(th)=0
if(t2>eps):
# zero angle: axis arbitrary
th=0.0
v[:]=1.0/numpy.sqrt(3.0)
else:
# rotation by pi
th=numpy.pi
if((rotp[0,0]>=rotp[1,1])&(rotp[0,0]>=rotp[2,2])):
if(rotp[0,0]<(-1.0+eps)):
mpi.report(rotp[0,0],-1.0+eps)
raise "sym_converter : Invalid rotation matrix!"
v[0]=numpy.sqrt(abs(rotp[0,0]+1.0)/2.0)
v[1]=(rotp[1,0]+rotp[0,1])/(4.0*v[0])
v[2]=(rotp[2,0]+rotp[0,2])/(4.0*v[0])
elif((rotp[1,1]>=rotp[0,0])&(rotp[1,1]>=rotp[2,2])):
if(rotp[1,1]<(-1.0+eps)):
mpi.report(rotp[1,1],-1.0+eps)
raise "sym_converter : Invalid rotation matrix!"
v[1]=numpy.sqrt(abs(rotp[1,1]+1.0)/2.0)
v[2]=(rotp[2,1]+rotp[1,2])/(4.0*v[1])
v[0]=(rotp[0,1]+rotp[1,0])/(4.0*v[1])
else:
if(rotp[2,2]<(-1.0+eps)):
mpi.report(rotp[2,2],-1.0+eps)
raise "sym_converter : Invalid rotation matrix!"
v[2]=numpy.sqrt(abs(rotp[2,2]+1.0)/2.0)
v[0]=(rotp[0,2]+rotp[2,0])/(4.0*v[2])
v[1]=(rotp[1,2]+rotp[2,1])/(4.0*v[2])
# return theta and v
return v,th
def axangsu2(self,v,th):
"""
Calculate the rotation SU(2) matrix - see Elk's axangsu2 routine.
"""
su2=numpy.zeros([2,2], numpy.complex_)
t1=numpy.sqrt(numpy.dot(v,v))
if(t1<1E-8):
raise "sym_converter : zero length axis vector!"
# normalise the vector
t1=1.0/t1
x=v[0]*t1; y=v[1]*t1; z=v[2]*t1
#calculate the SU(2) matrix
cs=numpy.cos(0.5*th)
sn=numpy.sin(0.5*th)
su2[0,0]=cs-z*sn*1j
su2[0,1]=-y*sn-x*sn*1j
su2[1,0]=y*sn-x*sn*1j
su2[1,1]=cs+z*sn*1j
#return the SU(2) matrix
return su2
def v3frac(self,v,eps):
"""
This finds the fractional part of 3-vector v components. This uses the
same method as in Elk (version 6.2.8) r3fac subroutine.
"""
v[0]=v[0]-numpy.floor(v[0])
if(v[0] < 0): v[0]+=1
if((1-v[0]) < eps): v[0]=0
if(v[0] < eps): v[0]=0
v[1]=v[1]-numpy.floor(v[1])
if(v[1] < 0): v[1]+=1
if((1-v[1]) < eps): v[1]=0
if(v[1] < eps): v[1]=0
v[2]=v[2]-numpy.floor(v[2])
if(v[2] < 0): v[2]+=1
if((1-v[2]) < eps): v[2]=0
if(v[2] < eps): v[2]=0
return v
def gen_perm(self,nsym,ns,na,natmtot,symmat,tr,atpos,epslat=1E-6):
"""
Generate the atom permutations per symmetry.
"""
perm=[]
iea=[]
for isym in range(nsym):
iea.append(numpy.zeros([natmtot,ns], numpy.int_))
#loop over species
for js in range(ns):
#loop over species atoms
v=numpy.zeros([3,na[js]], numpy.float_)
v2=numpy.zeros(3, numpy.float_)
for ia in range(na[js]):
v[:,ia]=self.v3frac(atpos[js][ia][0:3],epslat)
for ia in range(na[js]):
v2[:]=numpy.matmul(symmat[isym][:,:],(atpos[js][ia][0:3]+tr[isym]))
v2[:]=self.v3frac(v2,epslat)
for ja in range(na[js]):
t1=sum(abs(v[:,ja]-v2[:])) #check
if(t1 < epslat):
iea[isym][ja,js]=ia
break
#put iea into perm format
for isym in range(nsym):
perm.append([])
ja=0
prv_atms=0
for js in range(ns):
for ia in range(na[js]):
perm[isym].append(iea[isym][ia,js]+prv_atms+1)
ja+=1
prv_atms+=na[js]
#output perm
return perm
def symlat_to_complex_harmonics(self,nsym,n_shells,symlat,shells):
"""
This calculates the Elk (crystal) symmetries in complex spherical harmonics
This follows the methodology used in Elk's rotzflm, ylmrot and ylmroty routines.
"""
#need SciPy routines to get Euler angles - need version 1.4+
#from scipy.spatial.transform import Rotation as R
symmat=[]
rot=numpy.identity(3, numpy.float_)
angi=numpy.zeros(3, numpy.float_)
#loop over symmetries
for isym in range(nsym):
symmat.append([])
for ish in range(n_shells):
l=shells[ish]['l']
symmat[isym].append(numpy.zeros([2*l+1, 2*l+1], numpy.complex_))
#get determinant
det=numpy.linalg.det(symlat[isym])
p=1
#p is -1 for improper symmetries
if(det<0.0): p=-1
rot[:,:]=p*symlat[isym][:,:]
#r=R.from_matrix(rot)
#get the y-convention Euler angles as used by Elk.
#ang=r.as_euler('zyz')
ang=self.zyz_euler(rot)
#Elk uses inverse rotations, i.e. the function is being rotated, not the spherical harmonics
angi[0]=-ang[2]
angi[1]=-ang[1]
angi[2]=-ang[0]
#calculate the symmetry in the complex spherical harmonic basis.
d = self.ylmrot(p,angi,l)
symmat[isym][ish][:,:] = d[:,:]
#return the complex spherical harmonic
return symmat
def zyz_euler(self,rot):
"""
This calculates the Euler angles of matrix rot in the y-convention.
See Elk's roteuler routine.
This will be made redundent when TRIQS uses scipy version 1.4+
"""
eps=1E-8
pi=numpy.pi
ang=numpy.zeros(3, numpy.float_)
#get the Euler angles
if((abs(rot[2,0])>eps) or (abs(rot[2,1])>eps)):
ang[0]=numpy.arctan2(rot[2,1],rot[2,0])
if(abs(rot[2,0])>abs(rot[2,1])):
ang[1]=numpy.arctan2(rot[2,0]/numpy.cos(ang[0]),rot[2,2])
else:
ang[1]=numpy.arctan2(rot[2,1]/numpy.sin(ang[0]),rot[2,2])
ang[2]=numpy.arctan2(rot[1,2],-rot[0,2])
else:
ang[0]=numpy.arctan2(rot[0,1],rot[0,0])
if(rot[2,2]>0.0):
ang[1]=0.0
ang[2]=0.0
else:
ang[1]=pi
ang[2]=pi
#return Euler angles
return ang
def ylmrot(self,p,angi,l):
"""
calculates the rotation matrix in complex spherical harmonics for l.
THIS HAS ONLY BEEN TESTED FOR l=2.
"""
d=numpy.identity(2*l+1, numpy.complex_)
# generate the rotation matrix about the y-axis
dy=self.ylmroty(angi[1],l)
# apply inversion to odd l values if required
if(p==-1):
if(l % 2.0 != 0):
dy*=-1
# rotation by alpha and gamma
for m1 in range(-l,l+1,1):
lm1=l+m1
for m2 in range(-l,l+1,1):
lm2=l+m2
t1=-m1*angi[0]-m2*angi[2]
d[lm1,lm2]=dy[lm1,lm2]*(numpy.cos(t1)+1j*numpy.sin(t1))
#return the rotation matrix
return d
def ylmroty(self,beta,l):
"""
returns the rotation matrix around the y-axis with angle beta.
This uses the same real matrix formual as in Elk - see Elk's manual for ylmroty description
"""
#import the factorial function - needed for later versions of scipy (needs testing)
from scipy import special as spec
#calculates the rotation matrix in complex spherical harmonics for l
dy=numpy.identity(2*l+1, numpy.float_)
#sine and cosine of beta
cb=numpy.cos(beta/2.0)
sb=numpy.sin(beta/2.0)
# generate the rotaion operator for m-components of input l
for m1 in range(-l,l+1,1):
for m2 in range(-l,l+1,1):
sm=0.0
minlm=numpy.amin([l+m1, l-m2]) + 1
for k in range(minlm):
if(((l+m1-k)>=0) and ((l-m2-k)>=0) and ((m2-m1+k)>=0)):
j=2*(l-k)+m1-m2
if(j==0):
t1=1.0
else:
t1=cb**j
j=2*k+m2-m1
if(j!=0):
t1=t1*sb**j
t2=t1/(spec.factorial(k)*spec.factorial(l+m1-k)*spec.factorial(l-m2-k)*spec.factorial(m2-m1+k))
if(k % 2.0 != 0):
t2=-t2
sm+=t2
t1=numpy.sqrt(spec.factorial(l+m1)*spec.factorial(l-m1)*spec.factorial(l+m2)*spec.factorial(l-m2))
dy[m1+l,m2+l]=t1*sm
#return y-rotation matrix
return dy

View File

@ -0,0 +1,687 @@
##########################################################################
#
# TRIQS: a Toolbox for Research in Interacting Quantum Systems
#
# Copyright (C) 2019 by A. D. N. James, M. Zingl and M. Aichhorn
#
# TRIQS is free software: you can redistribute it and/or modify it under the
# terms of the GNU General Public License as published by the Free Software
# Foundation, either version 3 of the License, or (at your option) any later
# version.
#
# TRIQS is distributed in the hope that it will be useful, but WITHOUT ANY
# WARRANTY; without even the implied warranty of MERCHANTABILITY or FITNESS
# FOR A PARTICULAR PURPOSE. See the GNU General Public License for more
# details.
#
# You should have received a copy of the GNU General Public License along with
# TRIQS. If not, see <http://www.gnu.org/licenses/>.
#
##########################################################################
from types import *
import numpy
from triqs_dft_tools.converters.converter_tools import *
import os.path
from locale import atof
class readElkfiles:
"""
Read in the Elk output files for the elk_converter.py routines.
"""
def __init__(self):
self.dft_file = 'PROJ.OUT'
self.band_file = 'BAND.OUT'
self.eval_file = 'EIGVAL.OUT'
self.efermi_file = 'EFERMI.OUT'
self.kp_file = 'KPOINTS.OUT'
self.geom_file='GEOMETRY.OUT'
def read_elk_file(self, filename, to_replace):
#this function is almost identical to read_fortran_file, but it removes words after ':'
"""
Returns a generator that yields all numbers in the Fortran file as float, with possible replacements.
Parameters
----------
filename : string
Name of Fortran-produced file.
to_replace : dict of str:str
Dictionary defining old_char:new_char.
Yields
------
string
The next number in file.
"""
#import os.path
#import string
import locale
from locale import atof
if not(os.path.exists(filename)):
raise IOError("File %s does not exist." % filename)
for line in open(filename, 'r'):
for old, new in to_replace.items():
line = line.replace(old, new)
# removes the substring after ':' character - if it exists
if ":" in line:
line = self.split_string(line)
if "(" in line:
line = self.split_string3(line)
for x in line.split():
yield atof(x)
def read_elk_file2(self, filename, to_replace):
#this function is almost identical to read_fortran_file, but it removes words after '('
"""
Returns a generator that yields all numbers in the Fortran file as float, with possible replacements.
Parameters
----------
filename : string
Name of Fortran-produced file.
to_replace : dict of str:str
Dictionary defining old_char:new_char.
Yields
------
string
The next number in file.
"""
import os.path
import string
if not(os.path.exists(filename)):
raise IOError("File %s does not exist." % filename)
for line in open(filename, 'r'):
for old, new in to_replace.items():
line = line.replace(old, new)
# removes the substring after '(' character - if it exists
if "(" in line:
line = self.split_string2(line,'(')
# removes the substring after '+' character - if it exists
if "+" in line:
line = self.split_string2(line,'+')
# removes the substring after '|' character - if it exists
if "|" in line:
line = self.split_string2(line,'|')
#only include lines which have multiple characters
if(len(line)>1):
yield line.split()
def split_string(self,line):
"""
This removes the excess information after ':' of the string read in from the file
"""
temp = line.split(':')
line = temp[0]
return line
def split_string2(self,line,str):
"""
This removes the excess information after 'str' of the string read in from the file
"""
temp = line.split(str)
line = temp[0]
return line
def split_string3(self,line):
"""
This removes the excess information after '(' of the string read in from the file
"""
temp = line.split('(')
line = temp[0]
return line
def read_proj(self,dft_file):#,things_to_set):
"""
This function reads the contents of PROJ.OUT and returns them for general use.
"""
#read in PROJ.OUT file
R = self.read_elk_file( dft_file, self.fortran_to_replace)
try:
#arrays of entry names
gen_info_entries = ['nproj', 'n_k', 'spinpol', 'SO','natm']
proj_entries = ['sort', 'natom', 'l', 'dim']
at_entries = ['spatom','atom']
#Read in the No. of projectors, no. of k-points, spin and spinorb info
gen_info = {name: int(val) for name, val in zip(gen_info_entries, R)}
#mpi.report(gen_info)
#read in the information of all the projectors
#initialized variables
icorr=0
lmax=3 #maximum l value that will be used
n_shells=0
n_inequiv_shells=0
#local arrays
neqatom=[]#numpy.zeros([n_shells], numpy.int)
proj=[]
shells=[]#numpy.zeros([n_shells], numpy.int)
corr_shells=[]#numpy.zeros([n_shells], numpy.int)
prjtype=[]
wan=[]
proj_info=[]#numpy.zeros([n_shells], numpy.int)
T=[]
basis=[]
inequiv_to_corr=[]
corr_to_inequiv=[]
ind=[]
proj_idx=[]
at=[]
idxlm=[]
#assign global variables
n_k=gen_info['n_k']
SO=gen_info['SO']
#loop over projector flags
for ip in range(gen_info['nproj']):
#projector index
proj_idx.append(int(next(R)))
proj.append({name: int(val) for name, val in zip(proj_entries, R)})
na=proj[ip]['natom'] # integer which reduces when reading in atom info
while(na>0):
neqatom.append(int(next(R)))
na-=neqatom[ip]
#appends the mapping array to index of inequivalent atom in shells
inequiv_to_corr.append(icorr)
for ia in range(neqatom[ip]):
corr_to_inequiv.append(n_inequiv_shells)
at.append({name: int(val) for name, val in zip(at_entries, R)})
shells.append(proj[ip].copy())
shells[n_shells].update({'atom':at[n_shells]['atom'], 'spatom':at[n_shells]['spatom']})
corr_shells.append(shells[n_shells].copy())
n_orb=2*shells[n_shells]['l']+1
#lm submatrix indices
idxlm.append(numpy.zeros(2*lmax+1, dtype=numpy.int_))
nrep=proj[ip]['dim']
for i in range(nrep):
idxlm[n_shells][i]=next(R)-1
ind.append(idxlm[n_shells][0:nrep])
#determine basis type and transformation matrix
basis.append(int(next(R)))
#determine whether which basis the projectors where generated in
#spherical harmonics
T.append(numpy.zeros([n_orb, n_orb], dtype=numpy.complex_))
#Elk generated unitary basis
if (basis[n_shells]==2):
#reads the transformation matrix
for i in range(n_orb):
for j in range(n_orb):
T[n_shells][i, j] = next(R)
for i in range(n_orb):
for j in range(n_orb):
T[n_shells][i, j] += 1j * next(R)
#transformation matrix from spherical harmonics to cubic basis
elif (basis[n_shells]==1):
T[n_shells]=self.determine_T(shells[n_shells]['l'])
else:
for i in range(n_orb):
T[n_shells][i,i] = 1.0
#index for the next inequivalent atom (+1 to index is not needed as this is incorporated in
#neqatom[ish]
n_shells+=1
#increase the numer of inequivalent atoms
n_inequiv_shells+=1
#increase the inequiv_to_corr value
icorr+=neqatom[ip]
#end reading the file if read the last projector
if (ip+1==gen_info['nproj']):
break
#determine the irreducible representation
dim_reps=[]
n_reps=[]
irep=[]
for ish in range(n_inequiv_shells):
isheq=inequiv_to_corr[ish]
[n_reps,dim_reps,irep] = self.determine_rep(isheq,ish,corr_shells,basis,ind,n_reps,dim_reps,irep)
for ish in range(n_shells):
ishin=corr_to_inequiv[ish]
corr_shells[ish].update({'SO':SO, 'irep':irep[ishin]})
except StopIteration: # a more explicit error if the file is corrupted.
#raise "Elk_converter : reading PROJ.OUT file failed!"
raise IOError("Elk_converter : reading PROJ.OUT file failed!")
R.close()
#output desired information
return (gen_info,n_shells,n_inequiv_shells,corr_to_inequiv,inequiv_to_corr,corr_shells,n_reps,dim_reps,ind,basis,T)
def determine_T(self,l):
"""
Current version calculates the transformation matrix T to convert the inputs from spherical
harmonics to the cubic basis (as used in TRIQS and Wien2k).
This routine is currently very similar to spherical_to_cubic in the TRIQS library.
This routine can be extended to include other unitary rotation matrices
"""
from math import sqrt
size=2*l+1
T = numpy.zeros((size,size),dtype=complex)
if(l == 0):
T[0,0]= 1.0
elif(l == 1):
T[0,0] = 1.0/sqrt(2); T[0,2] = -1.0/sqrt(2)
T[1,0] = 1j/sqrt(2); T[1,2] = 1j/sqrt(2)
T[2,1] = 1.0
elif l == 2:
T[0,2] = 1.0
T[1,0] = 1.0/sqrt(2); T[1,4] = 1.0/sqrt(2)
T[2,0] =-1.0/sqrt(2); T[2,4] = 1.0/sqrt(2)
T[3,1] = 1.0/sqrt(2); T[3,3] =-1.0/sqrt(2)
T[4,1] = 1.0/sqrt(2); T[4,3] = 1.0/sqrt(2)
elif l == 3:
#This needs to be checked
T[0,0] = 1.0/sqrt(2); T[0,6] = -1.0/sqrt(2)
T[1,1] = 1.0/sqrt(2); T[1,5] = 1.0/sqrt(2)
T[2,2] = 1.0/sqrt(2); T[2,4] = -1.0/sqrt(2)
T[3,3] = 1.0
T[4,2] = 1j/sqrt(2); T[4,4] = 1j/sqrt(2)
T[5,1] = 1j/sqrt(2); T[5,5] = -1j/sqrt(2)
T[6,0] = 1j/sqrt(2); T[6,6] = 1j/sqrt(2)
else: raise ValueError("determine: implemented only for l=0,1,2,3")
return numpy.matrix(T)
def determine_rep(self,ish,ishin,corr_shells,basis,ind,n_reps,dim_reps,irep):
"""
Determines the irreducible representation used for projection calculation.
Only for Cubic harmonics at the moment
"""
#if all of the orbitals were used to construct the projectors
rep=corr_shells[ish]['dim']
if(rep==2*corr_shells[ish]['l']+1):
n_reps.append(1)
dim_reps.append([corr_shells[ish]['dim']])
irep.append(1)
#if a subset of obitals were used for generating the projectors (l>1)
#if Elk generated T matrix is used
elif((basis[ish]==2)&(corr_shells[ish]['l']>1)):
if (corr_shells[ish]['l']==2):
n_reps.append(2)
dim_reps.append([3, 2])
irep.append(dim_reps[ishin].index(rep)+1)
elif (corr_shells[ish]['l']==3):
n_reps.append(3)
dim_reps.append([1, 3, 3])
#cubic T matrix
elif((basis[ish]==1)&(corr_shells[ish]['l']>1)):
if (corr_shells[ish]['l']==2):
n_reps.append(2)
dim_reps.append([2, 3])
irep.append(dim_reps[ishin].index(rep)+1)
elif (corr_shells[ish]['l']==3):
n_reps.append(3)
dim_reps.append([2, 2, 3])
#determine the dim_reps from the lm indices in ind
if(rep==3):
irep.append(3)
else:
for i in range(2):
#look for ind[i]==0
if(ind[i]==0):
irep.append(1)
break
#default to irep=2
elif(i==1):
irep.append(2)
else:
raise ValueError("Elk_converter (determine_rep) : irreducible representations were not found!")
return (n_reps,dim_reps,irep)
def read_projector(self,shell,n_spin_blocks,ish,proj_mat,ind,T,basis,filext):
"""
This function reads the contents of WANPROJ_L**_S**_A****.OUT
"""
import string
l = str(shell[ish]['l']).zfill(2)
s = str(shell[ish]['sort']).zfill(2)
a = str(shell[ish]['spatom']).zfill(4)
#construct file name from atoms info
wan_shells_file = 'WANPROJ_L'+l+'_S'+s+'_A'+a+filext
R = self.read_elk_file(wan_shells_file, self.fortran_to_replace)
try:
#no. of kpts and number of orbital
gen_entries = ['n_k', 'lmmax','dim_rep']
gen = {name: int(val) for name, val in zip(gen_entries, R)}
#projector lm size
dim=gen['lmmax']
#no. of lm used to construct projector
dim_rep=gen['dim_rep']
lat=[]
n_k=gen['n_k']
n_orbitals = numpy.zeros([n_k, n_spin_blocks], numpy.int)
band_window = [None for isp in range(n_spin_blocks)]
for isp in range(n_spin_blocks):
band_window[isp] = numpy.zeros([n_k, 2], dtype=int)
for ik in range(0,n_k):
#k-point index and correlated band window indices
lat_entries = ['ik','vklx','vkly','vklz']
lat.append({name: int(val) for name, val in zip(lat_entries, R)})
#loop over each spin
for isp in range(0,n_spin_blocks):
#band window indices
proj_entries = ['isp', 'ist_min','ist_max']
proj_dim={name: int(val) for name, val in zip(proj_entries, R)}
if(isp+1!=proj_dim['isp']):
raise IOError("Elk_converter (",wan_shells_file,") : reading spin projecotrs failed!")
return
#setting band window arrays
n_orbitals[ik,isp]=proj_dim['ist_max']-proj_dim['ist_min']+1
band_window[isp][ik, 0] = proj_dim['ist_min']
band_window[isp][ik, 1] = proj_dim['ist_max']
#define temporary matrix for reading in the projectors
mat = numpy.zeros([dim, n_orbitals[ik,isp]], numpy.complex_)
# Real part
for j in range(dim):
for i in range(n_orbitals[ik,isp]):
mat[j, i] = next(R)
# Imag part:
for j in range(dim):
for i in range(n_orbitals[ik,isp]):
mat[j, i] += 1j * next(R)
#rotate projectors into basis T
if(basis[ish]!=0):
mat[:,:]=numpy.matmul(T[ish],mat[:,:])
#put desired projector subset into master array
proj_mat[ik,isp,ish,0:dim_rep,0:n_orbitals[ik,isp]]=mat[ind[ish],0:n_orbitals[ik,isp]]
#delete temporary index
del mat
#resize array length of band indices to maximum number used
proj_mat=proj_mat[:,:,:,:,:numpy.max(n_orbitals)]
except StopIteration: # a more explicit error if the file is corrupted.
raise IOError("Elk_converter (read projectors): reading file failed!")
R.close()
return(n_orbitals,band_window,dim_rep,proj_mat)
def read_eig(self,filext=".OUT"):
"""
This function reads the contents of EIGVAL.OUT and EFERMI.OUT
"""
import string
#construct file name from atoms info
R = self.read_elk_file( self.efermi_file, self.fortran_to_replace)
try:
efermi=next(R)
except StopIteration: # a more explicit error if the file is corrupted.
raise IOError("Elk_converter (EFERMI.OUT): reading file failed!")
eval_file = 'EIGVAL'+filext
R = self.read_elk_file( eval_file, self.fortran_to_replace)
try:
#no. of kpts
n_k=int(next(R))
#no. second variation states (no. bands)
nstsv=int(next(R))
en=[]
occ=[]
kp2=[]
for ik in range(0,n_k):
#k index and corresponing lattice coordinates
k_entries = ['ik', 'vklx','vkly','vklz']
kp2.append([{name: val for name, val in zip(k_entries, R)}])
en.append([])
occ.append([])
for ist in range(0,nstsv):
#stores the band index, energy eigenvalues and occupancies
en_entries = ['ist', 'hopping','occ']
read_en={name: val for name, val in zip(en_entries, R)}
#Energy eigenvalues and occupations
en[ik].append(read_en['hopping']-efermi)
occ[ik].append(read_en['occ'])
except StopIteration: # a more explicit error if the file is corrupted.
raise IOError("Elk_converter (EIGVAL.OUT): reading file failed!")
R.close()
return(en,occ,nstsv)
def read_kpoints(self,filext=".OUT"):
"""
This function reads the contents of KPOINTS.OUT
"""
import string
kp_file = 'KPOINTS'+filext
R = self.read_elk_file( kp_file, self.fortran_to_replace)
try:
#no. of kpts
n_k=int(next(R))
kp=[]
#reads in the k index, lattice vectors, weights and nmat for each kpt
#array for bz weights
bz_weights = numpy.ones([n_k], numpy.float_) / float(n_k)
#array for lattice vectors
vkl = numpy.ones([n_k,3], numpy.float_)
for ik in range(n_k):
#k-grid info
k_entries = ['ik', 'vklx','vkly','vklz', 'bz_weights', 'nmat']
kp.append({name: val for name, val in zip(k_entries, R)})
#convert to integers
kp[ik]['ik']=int(kp[ik]['ik'])
#read in BZ weights
bz_weights[ik]=kp[ik]['bz_weights']
j=0
for i in range(1,4):
vkl[ik,j]=kp[ik][k_entries[i]]
j=j+1
except StopIteration: # a more explicit error if the file is corrupted.
raise IOError("Elk_converter (KPOINTS.OUT): reading file failed!")
R.close()
return(bz_weights,vkl)
def readsym(self):
"""
Read in the (crystal) symmetries in lattice coordinates
"""
dft_file='SYMCRYS.OUT'
R = self.read_elk_file2( dft_file, self.fortran_to_replace)
try:
symmat=[]
spinmat=[]
tr=[]
#maximum symmetries
nsym = 48
#set up symmetry matrices
for isym in range(nsym):
symmat.append(numpy.zeros([3, 3], numpy.float_))
spinmat.append(numpy.zeros([3, 3], numpy.float_))
tr.append(numpy.zeros([3], numpy.float_))
#read the number of crystal symmetries
x = next(R)
nsym = int(atof(x[0]))
#read each symmetry
for isym in range(nsym):
#read the symmetry index and check it
x = next(R)
isymm = int(x[3])
if(isym+1!=isymm):
raise IOError("Elk_converter : reading symmetries failed!")
#next read has no useful infomation
x = next(R)
#read in the translation vector used for symmetries
x = next(R)
for i in range(3):
tr[isym][i]=atof(x[i])
#read in the spatial symmetries
#string with no useful information
x = next(R)
#read in the spatial symmetry
for i in range(3):
x = next(R)
for j in range(3):
symmat[isym][i,j]=int(atof(x[j]))
#string with no useful information
x = next(R)
#read in the spin symmetries
for i in range(3):
x = next(R)
for j in range(3):
spinmat[isym][i,j]=int(atof(x[j]))
except StopIteration: # a more explicit error if the file is corrupted.
raise IOError("Elk_converter : reading SYMCRYS.OUT file failed!")
R.close()
return nsym,spinmat,symmat,tr
def readlat(self):
"""
Read in the symmetries in lattice coordinates
"""
dft_file='LATTICE.OUT'
R = self.read_elk_file2( dft_file, self.fortran_to_replace)
try:
amat = numpy.zeros([3, 3], numpy.float_)
amatinv = numpy.zeros([3, 3], numpy.float_)
bmat = numpy.zeros([3, 3], numpy.float_)
bmatinv = numpy.zeros([3, 3], numpy.float_)
#real space lattice matrices
#cycling through information which is not needed
for i in range(4):
x = next(R)
#reading in the lattice vectors as matrix
for i in range(3):
x = next(R)
for j in range(3):
amat[i,j] = atof(x[j])
#cycling through information which is not needed
x = next(R)
#reading in the inverse lattice matrix
for i in range(3):
x = next(R)
for j in range(3):
amatinv[i,j] = atof(x[j])
#reciprocal lattice matrices
#cycling through information which is not needed
for i in range(5):
x = next(R)
#reading in the reciprocal lattice vectors as matrix
for i in range(3):
x = next(R)
for j in range(3):
bmat[i,j] = atof(x[j])
#cycling through information which is not needed
x = next(R)
#reading in the inverse reciprocal lattice matrix
for i in range(3):
x = next(R)
for j in range(3):
bmatinv[i,j] = atof(x[j])
except StopIteration: # a more explicit error if the file is corrupted.
raise IOError("Elk_converter : reading PROJ.OUT file failed!")
R.close()
return amat,amatinv,bmat,bmatinv
def read_geometry(self):
"""
This function reads the contents of GEOMETRY.OUT
"""
import string
#read in the Geometery file
dft_file='GEOMETRY.OUT'
#atom positions in lattice coordinates
R = self.read_elk_file2( dft_file, self.fortran_to_replace)
nspecies=0
na=[]
atpos_entries = ['kx', 'ky','kz','Bkx', 'Bky', 'Bkz']
atpos=[]
try:
i=0
#cycle through file until "atoms" is found
while(i<1000):
x = next(R)
if "atoms" in x:
break
elif(i==1000):
raise IOError("Elk_converter : Could not find 'atoms' in GEOMETRY.OUT!")
i+=1
#read in the number of species
x = next(R)
ns = int(atof(x[0]))
#loop over species
for js in range(ns):
#Skip species name
x = next(R)
#read in the number of atoms per species
x = next(R)
na.append(int(atof(x[0])))
#loop over atomss pre species
atpos.append([])
for ia in range(na[js]):
atpos[js].append(numpy.zeros(6, numpy.float_))
x = next(R)
for j in range(6):
atpos[js][ia][j]=atof(x[j])
except StopIteration: # a more explicit error if the file is corrupted.
raise IOError("Elk_converter : Could not open GEOMETRY.OUT!")
R.close()
return ns, na, atpos
#band character dependent calculations
def read_bc(self):
"""
Read in the ELK generated band characters from BC.OUT
"""
#import string
file = 'BC.OUT'
R = self.read_elk_file(file, self.fortran_to_replace)
try:
#no. of kpts and number of orbital
gen_entries = ['maxlm', 'nspinor','natmtot','nstsv','nkpt','irep']
gen = {name: int(val) for name, val in zip(gen_entries, R)}
#projector lm size
#check the read in information complies with previous read in data
nspinor=self.SP+1
if(gen['nspinor'] != nspinor):
mpi.report('HDF file nspinor = %s'%nspinor)
mpi.report('BC.OUT nspinor = %s'%gen['nspinor'])
raise IOError("Elk_converter (",file,") : reading nspinor failed!")
return
if(gen['natmtot'] != self.n_atoms):
raise IOError("Elk_converter (",file,") : reading no. of atoms failed!")
return
if(gen['nstsv'] != self.nstsv):
raise IOError("Elk_converter (",file,") : reading all states failed!")
return
if(gen['nkpt'] != self.n_k):
raise IOError("Elk_converter (",file,") : reading kpoints failed failed!")
return
if(gen['irep'] == 0):
raise IOError("Elk_converter (",file,") : Band characters are in spherical hamonics, may have issues with the PDOS!")
return
dim=gen['maxlm']
lmax=numpy.sqrt(dim)-1
bc = numpy.zeros([dim,nspinor,self.n_atoms,self.nstsv,self.n_k], numpy.float_)
for ik in range(0,self.n_k):
for iatom in range(0,self.n_atoms):
for ispn in range(0,nspinor):
entry = ['ispn','ias','is','ia','ik']
ent = {name: int(val) for name, val in zip(entry, R)}
#k-point index and correlated band window indices
#check read in values
if(ent['ispn'] != ispn+1):
raise IOError("Elk_converter (",file,") : reading ispn failed!")
return
if(ent['ias'] != iatom+1):
raise IOError("Elk_converter (",file,") : reading iatom failed!")
return
if(ent['ik'] != ik+1):
raise IOError("Elk_converter (",file,") : reading ik failed!")
return
for ist in range(self.nstsv):
for lm in range(dim):
bc[lm,ispn,iatom,ist,ik] = next(R)
except StopIteration: # a more explicit error if the file is corrupted.
raise IOError("Elk_converter (read BC.OUT): reading file failed!")
R.close()
return(bc,dim)

View File

@ -42,7 +42,7 @@ class SumkDFT(object):
def __init__(self, hdf_file, h_field=0.0, use_dft_blocks=False,
dft_data='dft_input', symmcorr_data='dft_symmcorr_input', parproj_data='dft_parproj_input',
symmpar_data='dft_symmpar_input', bands_data='dft_bands_input', transp_data='dft_transp_input',
misc_data='dft_misc_input'):
misc_data='dft_misc_input',bc_data='dft_bandchar_input',fs_data='dft_fs_input'):
r"""
Initialises the class from data previously stored into an hdf5 archive.
@ -92,6 +92,8 @@ class SumkDFT(object):
self.bands_data = bands_data
self.transp_data = transp_data
self.misc_data = misc_data
self.bc_data = bc_data
self.fs_data = fs_data
self.h_field = h_field
self.block_structure = BlockStructure()
@ -1973,7 +1975,7 @@ class SumkDFT(object):
return self.chemical_potential
def calc_density_correction(self, filename=None, dm_type='wien2k'):
def calc_density_correction(self, filename=None, dm_type='wien2k',spinave=False):
r"""
Calculates the charge density correction and stores it into a file.
@ -1997,13 +1999,16 @@ class SumkDFT(object):
the corresponing total charge `dens`.
"""
assert dm_type in ('vasp', 'wien2k'), "'dm_type' must be either 'vasp' or 'wienk'"
assert dm_type in ('vasp', 'wien2k','elk'), "'dm_type' must be either 'vasp', 'wienk' or 'elk'"
#default file names
if filename is None:
if dm_type == 'wien2k':
filename = 'dens_mat.dat'
elif dm_type == 'vasp':
filename = 'GAMMA'
elif dm_type == 'elk':
filename = 'DMATDMFT.OUT'
assert isinstance(filename, str), ("calc_density_correction: "
"filename has to be a string!")
@ -2152,6 +2157,50 @@ class SumkDFT(object):
valim = (deltaN['up'][ik][inu, imu].imag + deltaN['down'][ik][inu, imu].imag) / 2.0
f.write(" %.14f %.14f"%(valre, valim))
f.write("\n")
elif dm_type == 'elk':
# output each k-point density matrix for Elk
if mpi.is_master_node():
# read in misc data from .h5 file
things_to_read = ['band_window','vkl','nstsv']
self.subgroup_present, self.value_read = self.read_input_from_hdf(
subgrp=self.misc_data, things_to_read=things_to_read)
# open file
with open(filename, 'w') as f:
# determine the number of spin blocks
n_spin_blocks = self.SP + 1 - self.SO
nbmax = numpy.max(self.n_orbitals)
# output beta and mu in Hartrees
beta = G_latt_iw.mesh.beta * self.energy_unit
mu = self.chemical_potential/self.energy_unit
# ouput n_k, nspin and max orbitals - a check
f.write(" %d %d %d %.14f %.14f ! nkpt, nspin, nstmax, beta, mu\n"%(self.n_k, n_spin_blocks, nbmax, beta, mu))
for ik in range(self.n_k):
for ispn in range(n_spin_blocks):
#Determine the SO density matrix band indices from the spinor band indices
if(self.SO==1):
band0=[self.band_window[0][ik, 0],self.band_window[1][ik, 0]]
band1=[self.band_window[0][ik, 1],self.band_window[1][ik, 1]]
ib1=int(min(band0))
ib2=int(max(band1))
else:
#Determine the density matrix band indices from the spinor band indices
ib1 = self.band_window[ispn][ik, 0]
ib2 = self.band_window[ispn][ik, 1]
f.write(" %d %d %d %d ! ik, ispn, minist, maxist\n"%(ik + 1, ispn + 1, ib1, ib2))
for inu in range(self.n_orbitals[ik, ispn]):
for imu in range(self.n_orbitals[ik, ispn]):
#output non-magnetic or spin-averaged density matrix
if((self.SP==0) or (spinave)):
valre = (deltaN['up'][ik][inu, imu].real + deltaN['down'][ik][inu, imu].real) / 2.0
valim = (deltaN['up'][ik][inu, imu].imag + deltaN['down'][ik][inu, imu].imag) / 2.0
else:
valre = deltaN[spn[ispn]][ik][inu, imu].real
valim = deltaN[spn[ispn]][ik][inu, imu].imag
f.write(" %.14f %.14f"%(valre, valim))
f.write("\n")
else:
raise NotImplementedError("Unknown density matrix type: '%s'"%(dm_type))

View File

@ -186,8 +186,8 @@ class SumkDFTTools(SumkDFT):
f.close()
return DOS, DOSproj, DOSproj_orb
def dos_wannier_basis_all(self, mu=None, broadening=None, mesh=None, with_Sigma=True, with_dc=True, save_to_file=True):
"""
Calculates the density of states in the basis of the Wannier functions.
@ -235,7 +235,7 @@ class SumkDFTTools(SumkDFT):
#print(spn)
n_local_orbs = self.proj_mat_csc.shape[2]
gf_struct_parproj_all = [[(sp, list(range(n_local_orbs))) for sp in spn]]
glist_all = [GfReFreq(indices=inner, window=(om_min, om_max), n_points=n_om)
for block, inner in gf_struct_parproj_all[0]]
G_loc_all = BlockGf(name_list=spn, block_list=glist_all, make_copies=False)
@ -463,6 +463,361 @@ class SumkDFTTools(SumkDFT):
return DOS, DOSproj, DOSproj_orb
# Elk total and partial dos calculations
# Uses .data of only GfReFreq objects.
def elk_dos(self, mu=None, broadening=None, mesh=None, with_Sigma=True, with_dc=True, save_to_file=True,pdos=False,nk=None):
"""
This calculates the total DOS and the partial DOS (orbital-DOS) from the band characters calculated in Elk.
Parameters
----------
mu : double, optional
Chemical potential, overrides the one stored in the hdf5 archive.
broadening : double, optional
Lorentzian broadening of the spectra. If not given, standard value of lattice_gf is used.
mesh : real frequency MeshType, optional
Omega mesh for the real-frequency Green's function. Given as parameter to lattice_gf.
with_Sigma : boolean, optional
If True, the self energy is used for the calculation. If false, the DOS is calculated without self energy.
with_dc : boolean, optional
If True the double counting correction is used.
save_to_file : boolean, optional
If True, text files with the calculated data will be created.
pdos : allows the partial density of states to be calculated
nk : diagonal of the occupation function (from the Matsubara Green's function)
in the band basis (has form nk[spn][n_k][n_orbital])
Returns
-------
DOS : Dict of numpy arrays
Contains the full density of states.
pDOS : Dict of numpy arrays
partial (orbital resolved) DOS for each atom.
"""
if (pdos):
things_to_read = ['maxlm', 'bc']
value_read = self.read_input_from_hdf(
subgrp=self.bc_data, things_to_read=things_to_read)
if not value_read:
return value_read
things_to_read = ['n_atoms']
value_read = self.read_input_from_hdf(
subgrp=self.symmcorr_data, things_to_read=things_to_read)
if not value_read:
return value_read
if (mesh is None) and (not with_Sigma):
raise ValueError("lattice_gf: Give the mesh=(om_min,om_max,n_points) for the lattice GfReFreq.")
if mesh is None:
om_mesh = [x.real for x in self.Sigma_imp_w[0].mesh]
om_min = om_mesh[0]
om_max = om_mesh[-1]
n_om = len(om_mesh)
mesh = (om_min, om_max, n_om)
else:
om_min, om_max, n_om = mesh
om_mesh = numpy.linspace(om_min, om_max, n_om)
if mu is None:
mu = self.chemical_potential
spn = self.spin_block_names[self.SO]
DOS = {sp: numpy.zeros([n_om], numpy.float_)
for sp in self.spin_block_names[self.SO]}
#set up temporary arrays for pdos calculations
if (pdos):
pDOS = {sp: numpy.zeros([self.n_atoms,self.maxlm,n_om], numpy.float_)
for sp in self.spin_block_names[self.SO]}
ntoi = self.spin_names_to_ind[self.SO]
else:
pDOS = []
ikarray = numpy.array(range(self.n_k))
for ik in mpi.slice_array(ikarray):
G_latt_w = self.lattice_gf(
ik=ik, mu=mu, iw_or_w="w", broadening=broadening, mesh=mesh, with_Sigma=with_Sigma, with_dc=with_dc)
G_latt_w *= self.bz_weights[ik]
if(nk!=None):
for iom in range(n_om):
for bname, gf in G_latt_w:
numpy.fill_diagonal(G_latt_w[bname].data[iom,:,:].imag, nk[bname][ik][:]*G_latt_w[bname].data[iom,:,:].imag.diagonal())
# Non-projected DOS
for iom in range(n_om):
for bname, gf in G_latt_w:
DOS[bname][iom] -= gf.data[iom, :, :].imag.trace() / \
numpy.pi
# Partial DOS
if (pdos):
for bname, gf in G_latt_w:
isp=ntoi[bname]
nst=self.n_orbitals[ik,isp]
tmp = numpy.zeros([nst])
for iom in range(n_om):
#get diagonal spectral function
tmp[:] = -gf.data[iom, :, :].imag.diagonal() / numpy.pi
#calculate the pDOS of all atoms
for iatom in range(self.n_atoms):
bcar=self.bc[:,isp,iatom,0:nst,ik]
pDOS[bname][iatom,:,iom] += numpy.matmul(bcar,tmp)
del tmp
mpi.barrier()
# Collect data from mpi:
for bname in DOS:
DOS[bname] = mpi.all_reduce(
mpi.world, DOS[bname], lambda x, y: x + y)
if (pdos):
for bname in pDOS:
for iatom in range(self.n_atoms):
for lm in range(self.maxlm):
pDOS[bname][iatom,lm,:] = mpi.all_reduce(
mpi.world, pDOS[bname][iatom,lm,:], lambda x, y: x + y)
# Write to files
if save_to_file and mpi.is_master_node():
for sp in self.spin_block_names[self.SO]:
f = open('TDOS_%s.dat' % sp, 'w')
for iom in range(n_om):
f.write("%s %s\n" % (om_mesh[iom], DOS[sp][iom]))
f.close()
# Partial
if (pdos):
for iatom in range(self.n_atoms):
f = open('pDOS_%s_atom_%s.dat' % (sp, iatom), 'w')
for lm in range(self.maxlm):
for iom in range(n_om):
f.write("%s %s\n" %
(om_mesh[iom], pDOS[sp][iatom,lm,iom]))
f.write("\n")
f.close()
return DOS, pDOS
# vector manipulation used in Elk for symmetry operations - This is already in elktools, this should
# put somewhere for general use by the converter and this script.
def v3frac(self,v,eps):
#This finds the fractional part of 3-vector v components. This uses the
#same method as in Elk (version 6.2.8) r3fac subroutine.
v[0]=v[0]-numpy.floor(v[0])
if(v[0] < 0): v[0]+=1
if((1-v[0]) < eps): v[0]=0
if(v[0] < eps): v[0]=0
v[1]=v[1]-numpy.floor(v[1])
if(v[1] < 0): v[1]+=1
if((1-v[1]) < eps): v[1]=0
if(v[1] < eps): v[1]=0
v[2]=v[2]-numpy.floor(v[2])
if(v[2] < 0): v[2]+=1
if((1-v[2]) < eps): v[2]=0
if(v[2] < eps): v[2]=0
return v
# Calculate the spectral function at an energy contour omega - i.e. Fermi surface plots
# Uses .data of only GfReFreq objects.
def fs_plot(self, mu=None, broadening=None, mesh=None, FS=True, plane=True, sym=True, orthvec=None, with_Sigma=True, with_dc=True, save_to_file=True):
"""
Calculates the correlated spectral function at specific frequencies. The default output is the
correlated spectral function at zero frequency - this relates the the Fermi surface.
Parameters
----------
mu : double, optional
Chemical potential, overrides the one stored in the hdf5 archive.
broadening : double, optional
Lorentzian broadening of the spectra. If not given, standard value of lattice_gf is used.
mesh : real frequency MeshType, optional
Omega mesh for the real-frequency Green's function. Given as parameter to lattice_gf.
plane : boolean, optional
True assumes that the k-mesh of eigenvalues calculated was a plane.
sym: boolean, optional
Uses the symmetry operations to fold out the correlated spectral function in the BZ
FS: boolean
Flag for calculating the spectral function at the Fermi level (omega->0)
orthvec: double (3) element numpy array, optional
This is used to determine the vectors used in the plane calculations after folding out the IBZ.
This needs to correspond to the same orthonormal LATTICE inputs vectors used in the DFT code
which generated the plane of energy eigenvalues.
The default is orthvec=[0,0,1].
with_Sigma : boolean, optional
If True, the self energy is used for the calculation. If false, the DOS is calculated without self energy.
with_dc : boolean, optional
If True the double counting correction is used.
save_to_file : boolean, optional
If True, text files with the calculated data will be created.
Returns
-------
nk : int
The number of k-points in the plane.
vkc : Dict of numpy arrays [shape - (nk, 3)]
Contains the cartesian vectors which the spectral function has been evaluated on.
Akw : Dict of numpy arrays [shape - (spn)(self.n_k, n_om)]
Correlated spectral function - the data as it is written to the files.
iknr : int array
An array of k-point indices which mape the Akw over the unfolded BZ.
"""
#default vector tolerance used in Elk. This should not be alter.
epslat=1E-6
#read in the energy contour energies and projectors
things_to_read = ['n_k','bmat','symlat','n_symm','vkl',
'n_orbitals', 'proj_mat', 'hopping']
value_read = self.read_input_from_hdf(
subgrp=self.fs_data, things_to_read=things_to_read)
if not value_read:
return value_read
if with_Sigma is True:
om_mesh = [x.real for x in self.Sigma_imp_w[0].mesh]
#for Fermi Surface calculations
if FS:
jw=[i for i in range(len(om_mesh)) if om_mesh[i] == 0.0]
if len(jw)==0:
mpi.report('Sigma_imp_w mesh does not include zero frequency value')
mpi.report('Using the next absolute lowest frequency value.')
abs_om_mesh = [abs(i) for i in om_mesh]
jw=[i for i in range(len(abs_om_mesh)) if abs_om_mesh[i] == numpy.min(abs_om_mesh[:])]
mpi.report(jw)
#for many energy contour calculations
else:
if mesh:
om_mn=mesh[0]
om_mx=mesh[1]
jw=[i for i in range(len(om_mesh)) if((om_mesh[i]<=om_mx)and(om_mesh[i]>=om_mn))]
om_min = om_mesh[0]
om_max = om_mesh[-1]
n_om = len(om_mesh)
mesh = (om_min, om_max, n_om)
print(mesh)
if broadening is None:
broadening=0.0
print(broadening)
elif mesh is None:
#default is to set "mesh" to be just for the Fermi surface - omega=0.0
om_min = 0.000
om_max = 0.001
n_om = 3
mesh = (om_min, om_max, n_om)
om_mesh = numpy.linspace(om_min, om_max, n_om)
if broadening is None:
broadening=0.01
FS=True
print(with_Sigma,with_dc)
jw=[i for i in range(len(om_mesh)) if((om_mesh[i]<=om_max)and(om_mesh[i]>=om_min))]
else:
#a range of frequencies can be used if desired
om_min, om_max, n_om = mesh
om_mesh = numpy.linspace(om_min, om_max, n_om)
FS=False
jw=[i for i in range(len(om_mesh)) if((om_mesh[i]<=om_max)and(om_mesh[i]>=om_min))]
if mu is None:
mu = self.chemical_potential
#orthogonal vector used for plane calculations
if orthvec is None:
#set to [0,0,1] by default
orthvec = numpy.zeros(3,dtype=numpy.float_)
orthvec[2] = 1.0
elif orthvec.size != 3:
assert 0, "The input numpy orthvec is not the required size of 3!"
spn = self.spin_block_names[self.SO]
Akw = {sp: numpy.zeros([self.n_k, n_om], numpy.float_)
for sp in spn}
#Cartesian lattice coordinates array
vkc = numpy.zeros([self.n_k,3], numpy.float_)
ikarray = numpy.array(range(self.n_k))
for ik in mpi.slice_array(ikarray):
#calculate the catesian coordinates of IBZ
vkc[ik,:] = numpy.matmul(self.bmat,self.vkl[ik,:])
G_latt_w = self.lattice_gf(
ik=ik, mu=mu, iw_or_w="w", broadening=broadening, mesh=mesh, with_Sigma=with_Sigma, with_dc=with_dc)
for iom in range(n_om):
for bname, gf in G_latt_w:
Akw[bname][ik, iom] += gf.data[iom,:,:].imag.trace() / (-1.0 * numpy.pi)
mpi.barrier()
# Collect data from mpi:
for sp in spn:
Akw[sp] = mpi.all_reduce(mpi.world, Akw[sp], lambda x, y: x + y)
mpi.barrier()
#fold out the IBZ k-points using the lattice vectors and symmetries
#reducible number of k-points (which will alter after out folding)
nk = self.n_k
iknr = numpy.arange(self.n_k)
if sym:
vkltmp = self.vkl
v = numpy.zeros(3, numpy.float_)
v_orth = numpy.zeros(3, numpy.float_)
for isym in range(self.n_symm):
#calculate the orthonormal vector after symmetry operation. This is used to
#check if the orthonormal vector after the symmetry operation is parallel
#or anit-parallel to the original vector.
if plane:
vo = numpy.matmul(self.symlat[isym][:,:],orthvec[:].transpose())
#check if the vectors are parallel or anti-parallel respectively
t1 = numpy.array_equal(vo, orthvec)
if(not t1):
#exit this symmetry operation
continue
for ik in range(self.n_k):
#find point in BZ by symmetry operation
v[:]=numpy.matmul(self.symlat[isym][:,:],self.vkl[ik,:])
#shift back in to range [0,1) - Elk specific
v[:]=self.v3frac(v,epslat)
#add vector to list if not present and add the equivalent Akw value
#convert to cartesian
v[:] = numpy.matmul(self.bmat,v[:])
#alter temporary arrays
nk += 1
vkc = numpy.vstack((vkc,v))
iknr = numpy.append(iknr,ik)
vkltmp = numpy.vstack((vkltmp,v))
#remove duplicates
[vkc,ind]=numpy.unique(vkc,return_index=True,axis=0)
iknr=iknr[ind]
nk=vkc.shape[0]
#sort the indices for output in decending order
iksrt=numpy.lexsort(([vkc[:,i] for i in range(0,vkc.shape[1], 1)]))
#rearrange the vkc and iknr arrays
vkc=vkc[iksrt]
iknr=iknr[iksrt]
# Write to files
if save_to_file and mpi.is_master_node():
for sp in self.spin_block_names[self.SO]:
if FS:
#Output default FS spectral function
f = open('Akw_FS_%s.dat' % sp, 'w')
for ik in range(nk):
jk=iknr[ik]
f.write("%s %s %s %s\n" % (vkc[ik,0], vkc[ik,1], vkc[ik,2], Akw[bname][jk, jw[0]]))
f.close()
else:
#Output spectral function from multiple frequencies
for iom in jw:
#output the energy contours in multiple files with mesh index.
f = open('Akw_%s_omega_%s.dat' % (sp, iom), 'w')
for ik in range(nk):
jk=iknr[ik]
f.write("%s %s %s %s %s\n" % (vkc[ik,0], vkc[ik,1], vkc[ik,2], om_mesh[iom], Akw[bname][jk, iom]))
f.close()
return nk, vkc, Akw, iknr
# Uses .data of only GfReFreq objects.
def spaghettis(self, broadening=None, plot_shift=0.0, plot_range=None, ishell=None, mu=None, save_to_file='Akw_'):
"""
@ -497,7 +852,7 @@ class SumkDFTTools(SumkDFT):
subgrp=self.bands_data, things_to_read=things_to_read)
if not value_read:
return value_read
if ishell is not None:
if ishell:
things_to_read = ['rot_mat_all', 'rot_mat_all_time_inv']
value_read = self.read_input_from_hdf(
subgrp=self.parproj_data, things_to_read=things_to_read)
@ -792,12 +1147,12 @@ class SumkDFTTools(SumkDFT):
# Uses .data of only GfReFreq objects.
def transport_distribution(self, beta, directions=['xx'], energy_window=None, Om_mesh=[0.0], with_Sigma=False, n_om=None, broadening=0.0):
r"""
Calculates the transport distribution
Calculates the transport distribution
.. math::
\Gamma_{\alpha\beta}\left(\omega+\Omega/2, \omega-\Omega/2\right) = \frac{1}{V} \sum_k Tr\left(v_{k,\alpha}A_{k}(\omega+\Omega/2)v_{k,\beta}A_{k}\left(\omega-\Omega/2\right)\right)
in the direction :math:`\alpha\beta`. The velocities :math:`v_{k}` are read from the transport subgroup of the hdf5 archive.
in the direction :math:`\alpha\beta`. The velocities :math:`v_{k}` are read from the transport subgroup of the hdf5 archive.
Parameters
----------
@ -807,14 +1162,14 @@ class SumkDFTTools(SumkDFT):
directions : list of double, optional
:math:`\alpha\beta` e.g.: ['xx','yy','zz','xy','xz','yz'].
energy_window : list of double, optional
Specifies the upper and lower limit of the frequency integration for :math:`\Omega=0.0`. The window is automatically enlarged by the largest :math:`\Omega` value,
Specifies the upper and lower limit of the frequency integration for :math:`\Omega=0.0`. The window is automatically enlarged by the largest :math:`\Omega` value,
hence the integration is performed in the interval [energy_window[0]-max(Om_mesh), energy_window[1]+max(Om_mesh)].
Om_mesh : list of double, optional
:math:`\Omega` frequency mesh of the optical conductivity. For the conductivity and the Seebeck coefficient :math:`\Omega=0.0` has to be
part of the mesh. In the current version Om_mesh is repined to the mesh provided by the self-energy! The actual mesh is printed on the screen and stored as
member Om_mesh.
with_Sigma : boolean, optional
Determines whether the calculation is performed with or without self energy. If this parameter is set to False the self energy is set to zero (i.e. the DFT band
Determines whether the calculation is performed with or without self energy. If this parameter is set to False the self energy is set to zero (i.e. the DFT band
structure :math:`A(k,\omega)` is used). Note: For with_Sigma=False it is necessary to specify the parameters energy_window, n_om and broadening.
n_om : integer, optional
Number of equidistant frequency points in the interval [energy_window[0]-max(Om_mesh), energy_window[1]+max(Om_mesh)]. This parameters is only used if
@ -873,7 +1228,7 @@ class SumkDFTTools(SumkDFT):
n_om = len(self.omega)
mpi.report("Using omega mesh provided by Sigma!")
if energy_window is not None:
if energy_window:
# Find according window in Sigma mesh
ioffset = numpy.sum(
self.omega < energy_window[0] - max(Om_mesh))
@ -979,7 +1334,7 @@ class SumkDFTTools(SumkDFT):
def transport_coefficient(self, direction, iq, n, beta, method=None):
r"""
Calculates the transport coefficient A_n in a given direction for a given :math:`\Omega`. The required members (Gamma_w, directions, Om_mesh) have to be obtained first
by calling the function :meth:`transport_distribution <dft.sumk_dft_tools.SumkDFTTools.transport_distribution>`. For n>0 A is set to NaN if :math:`\Omega` is not 0.0.
by calling the function :meth:`transport_distribution <dft.sumk_dft_tools.SumkDFTTools.transport_distribution>`. For n>0 A is set to NaN if :math:`\Omega` is not 0.0.
Parameters
----------
@ -1042,10 +1397,10 @@ class SumkDFTTools(SumkDFT):
def conductivity_and_seebeck(self, beta, method=None):
r"""
Calculates the Seebeck coefficient and the optical conductivity by calling
:meth:`transport_coefficient <dft.sumk_dft_tools.SumkDFTTools.transport_coefficient>`.
The required members (Gamma_w, directions, Om_mesh) have to be obtained first by calling the function
:meth:`transport_distribution <dft.sumk_dft_tools.SumkDFTTools.transport_distribution>`.
Calculates the Seebeck coefficient and the optical conductivity by calling
:meth:`transport_coefficient <dft.sumk_dft_tools.SumkDFTTools.transport_coefficient>`.
The required members (Gamma_w, directions, Om_mesh) have to be obtained first by calling the function
:meth:`transport_distribution <dft.sumk_dft_tools.SumkDFTTools.transport_distribution>`.
Parameters
----------
@ -1060,7 +1415,7 @@ class SumkDFTTools(SumkDFT):
seebeck : dictionary of double
Seebeck coefficient in each direction. If zero is not present in Om_mesh the Seebeck coefficient is set to NaN.
kappa : dictionary of double.
kappa : dictionary of double.
thermal conductivity in each direction. If zero is not present in Om_mesh the thermal conductivity is set to NaN
"""

View File

@ -5,7 +5,7 @@ foreach(file ${all_h5_ref_files})
endforeach()
# Copy other files
FILE(COPY SrVO3.pmat SrVO3.struct SrVO3.outputs SrVO3.oubwin SrVO3.ctqmcout SrVO3.symqmc SrVO3.sympar SrVO3.parproj hk_convert_hamiltonian.hk LaVO3-Pnma_hr.dat LaVO3-Pnma.inp LaVO3-Pnma_ef_hr.dat LaVO3-Pnma_ef.inp LaVO3-Pbnm.inp LaVO3-Pbnm_hr.dat DESTINATION ${CMAKE_CURRENT_BINARY_DIR})
FILE(COPY SrVO3.pmat SrVO3.struct SrVO3.outputs SrVO3.oubwin SrVO3.ctqmcout SrVO3.symqmc SrVO3.sympar SrVO3.parproj hk_convert_hamiltonian.hk LaVO3-Pnma_hr.dat LaVO3-Pnma.inp LaVO3-Pnma_ef_hr.dat LaVO3-Pnma_ef.inp LaVO3-Pbnm.inp LaVO3-Pbnm_hr.dat EFERMI.OUT EIGVAL.OUT GEOMETRY.OUT KPOINTS.OUT LATTICE.OUT PROJ.OUT SYMCRYS.OUT WANPROJ_L02_S03_A0001.OUT DESTINATION ${CMAKE_CURRENT_BINARY_DIR})
# List of all tests

1
test/python/EFERMI.OUT Normal file
View File

@ -0,0 +1 @@
0.2995688599

5860
test/python/EIGVAL.OUT Normal file

File diff suppressed because it is too large Load Diff

38
test/python/GEOMETRY.OUT Normal file
View File

@ -0,0 +1,38 @@
scale
1.0
scale1
1.0
scale2
1.0
scale3
1.0
avec
7.888832000 7.888832000 0.000000000
7.888832000 -7.888832000 0.000000000
7.888832000 0.000000000 7.888832000
atoms
4 : nspecies
'O.in' : spfname
6 : natoms; atpos, bfcmt below
-0.23551000 -0.23551000 0.47102000 0.00000000 0.00000000 0.00000000
0.23551000 0.23551000 -0.47102000 0.00000000 0.00000000 0.00000000
0.23551000 0.23551000 0.00000000 0.00000000 0.00000000 0.00000000
-0.23551000 -0.23551000 0.00000000 0.00000000 0.00000000 0.00000000
0.23551000 -0.23551000 0.00000000 0.00000000 0.00000000 0.00000000
-0.23551000 0.23551000 0.00000000 0.00000000 0.00000000 0.00000000
'Ba.in' : spfname
2 : natoms; atpos, bfcmt below
0.25000000 -0.25000000 0.50000000 0.00000000 0.00000000 0.00000000
-0.25000000 0.25000000 0.50000000 0.00000000 0.00000000 0.00000000
'Ir.in' : spfname
1 : natoms; atpos, bfcmt below
0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000
'Y.in' : spfname
1 : natoms; atpos, bfcmt below
0.50000000 0.50000000 0.00000000 0.00000000 0.00000000 0.00000000

30
test/python/KPOINTS.OUT Normal file
View File

@ -0,0 +1,30 @@
29 : nkpt; k-point, vkl, wkpt, nmat below
1 0.000000000 0.000000000 0.000000000 0.1953125000E-02 979
2 0.1250000000 0.000000000 0.000000000 0.1562500000E-01 943
3 0.2500000000 0.000000000 0.000000000 0.1562500000E-01 937
4 0.3750000000 0.000000000 0.000000000 0.1562500000E-01 936
5 0.5000000000 0.000000000 0.000000000 0.7812500000E-02 942
6 0.1250000000 0.1250000000 0.000000000 0.2343750000E-01 947
7 0.2500000000 0.1250000000 0.000000000 0.4687500000E-01 935
8 0.3750000000 0.1250000000 0.000000000 0.4687500000E-01 938
9 0.5000000000 0.1250000000 0.000000000 0.4687500000E-01 935
10 0.6250000000 0.1250000000 0.000000000 0.4687500000E-01 934
11 0.7500000000 0.1250000000 0.000000000 0.4687500000E-01 946
12 0.8750000000 0.1250000000 0.000000000 0.1171875000E-01 951
13 0.2500000000 0.2500000000 0.000000000 0.2343750000E-01 929
14 0.3750000000 0.2500000000 0.000000000 0.4687500000E-01 934
15 0.5000000000 0.2500000000 0.000000000 0.4687500000E-01 932
16 0.6250000000 0.2500000000 0.000000000 0.4687500000E-01 939
17 0.7500000000 0.2500000000 0.000000000 0.1171875000E-01 943
18 0.3750000000 0.3750000000 0.000000000 0.2343750000E-01 934
19 0.5000000000 0.3750000000 0.000000000 0.4687500000E-01 923
20 0.6250000000 0.3750000000 0.000000000 0.1171875000E-01 927
21 0.5000000000 0.5000000000 0.000000000 0.5859375000E-02 916
22 0.2500000000 0.2500000000 0.1250000000 0.4687500000E-01 944
23 0.3750000000 0.2500000000 0.1250000000 0.9375000000E-01 929
24 0.5000000000 0.2500000000 0.1250000000 0.4687500000E-01 934
25 0.3750000000 0.3750000000 0.1250000000 0.4687500000E-01 931
26 0.5000000000 0.3750000000 0.1250000000 0.9375000000E-01 934
27 0.6250000000 0.3750000000 0.1250000000 0.4687500000E-01 924
28 0.5000000000 0.5000000000 0.1250000000 0.2343750000E-01 928
29 0.5000000000 0.5000000000 0.2500000000 0.1171875000E-01 902

41
test/python/LATTICE.OUT Normal file
View File

@ -0,0 +1,41 @@
+----------------------------+
| Real-space lattice vectors |
+----------------------------+
vector a1 : 7.888832000 7.888832000 0.000000000
vector a2 : 7.888832000 -7.888832000 0.000000000
vector a3 : 7.888832000 0.000000000 7.888832000
Stored column-wise as a matrix :
7.888832000 7.888832000 7.888832000
7.888832000 -7.888832000 0.000000000
0.000000000 0.000000000 7.888832000
Inverse of matrix :
0.6338073875E-01 0.6338073875E-01 -0.6338073875E-01
0.6338073875E-01 -0.6338073875E-01 -0.6338073875E-01
-0.000000000 -0.000000000 0.1267614775
Unit cell volume : 981.9019399
+----------------------------------+
| Reciprocal-space lattice vectors |
+----------------------------------+
vector b1 : 0.3982329264 0.3982329264 -0.3982329264
vector b2 : 0.3982329264 -0.3982329264 -0.3982329264
vector b3 : -0.000000000 -0.000000000 0.7964658529
Stored column-wise as a matrix :
0.3982329264 0.3982329264 -0.000000000
0.3982329264 -0.3982329264 -0.000000000
-0.3982329264 -0.3982329264 0.7964658529
Inverse of matrix :
1.255546608 1.255546608 0.000000000
1.255546608 -1.255546608 -0.000000000
1.255546608 -0.000000000 1.255546608
Brillouin zone volume : 0.2526221849

8
test/python/PROJ.OUT Normal file
View File

@ -0,0 +1,8 @@
1 29 2 1 10 : nproj, nkpt, nspinor, spinorb, natmtot
1 : Proj index
3 1 2 5 : Species index, natoms, l, lm submatrix size
1 : Subset no. of equivalent atoms
1 9 : atom, spatom
1 2 3 4 5 : lm indices
1 : Cubic Harmonics

580
test/python/SYMCRYS.OUT Normal file
View File

@ -0,0 +1,580 @@
(translation vectors and rotation matrices are in lattice coordinates)
48 : nsymcrys
Crystal symmetry : 1
spatial translation :
0.000000000 0.000000000 0.000000000
spatial rotation :
1 0 0
0 1 0
0 0 1
global spin rotation :
1 0 0
0 1 0
0 0 1
Crystal symmetry : 2
spatial translation :
0.000000000 0.000000000 0.000000000
spatial rotation :
-1 0 0
0 -1 0
0 0 -1
global spin rotation :
-1 0 0
0 -1 0
0 0 -1
Crystal symmetry : 3
spatial translation :
0.000000000 0.000000000 0.000000000
spatial rotation :
-1 0 -1
0 -1 -1
0 0 1
global spin rotation :
-1 0 -1
0 -1 -1
0 0 1
Crystal symmetry : 4
spatial translation :
0.000000000 0.000000000 0.000000000
spatial rotation :
-1 0 -1
0 -1 -1
1 1 1
global spin rotation :
-1 0 -1
0 -1 -1
1 1 1
Crystal symmetry : 5
spatial translation :
0.000000000 0.000000000 0.000000000
spatial rotation :
-1 0 -1
0 1 0
0 0 1
global spin rotation :
-1 0 -1
0 1 0
0 0 1
Crystal symmetry : 6
spatial translation :
0.000000000 0.000000000 0.000000000
spatial rotation :
-1 0 -1
0 1 0
1 -1 0
global spin rotation :
-1 0 -1
0 1 0
1 -1 0
Crystal symmetry : 7
spatial translation :
0.000000000 0.000000000 0.000000000
spatial rotation :
-1 0 0
-1 0 -1
1 -1 0
global spin rotation :
-1 0 0
-1 0 -1
1 -1 0
Crystal symmetry : 8
spatial translation :
0.000000000 0.000000000 0.000000000
spatial rotation :
-1 0 0
-1 0 -1
1 1 1
global spin rotation :
-1 0 0
-1 0 -1
1 1 1
Crystal symmetry : 9
spatial translation :
0.000000000 0.000000000 0.000000000
spatial rotation :
-1 0 -1
-1 0 0
1 1 1
global spin rotation :
-1 0 -1
-1 0 0
1 1 1
Crystal symmetry : 10
spatial translation :
0.000000000 0.000000000 0.000000000
spatial rotation :
-1 0 0
0 -1 0
1 1 1
global spin rotation :
-1 0 0
0 -1 0
1 1 1
Crystal symmetry : 11
spatial translation :
0.000000000 0.000000000 0.000000000
spatial rotation :
-1 0 0
0 1 1
0 0 -1
global spin rotation :
-1 0 0
0 1 1
0 0 -1
Crystal symmetry : 12
spatial translation :
0.000000000 0.000000000 0.000000000
spatial rotation :
-1 0 0
0 1 1
1 -1 0
global spin rotation :
-1 0 0
0 1 1
1 -1 0
Crystal symmetry : 13
spatial translation :
0.000000000 0.000000000 0.000000000
spatial rotation :
0 -1 -1
-1 0 -1
0 0 1
global spin rotation :
0 -1 -1
-1 0 -1
0 0 1
Crystal symmetry : 14
spatial translation :
0.000000000 0.000000000 0.000000000
spatial rotation :
0 -1 -1
-1 0 -1
1 1 1
global spin rotation :
0 -1 -1
-1 0 -1
1 1 1
Crystal symmetry : 15
spatial translation :
0.000000000 0.000000000 0.000000000
spatial rotation :
0 -1 -1
0 -1 0
-1 1 0
global spin rotation :
0 -1 -1
0 -1 0
-1 1 0
Crystal symmetry : 16
spatial translation :
0.000000000 0.000000000 0.000000000
spatial rotation :
0 -1 -1
0 -1 0
1 1 1
global spin rotation :
0 -1 -1
0 -1 0
1 1 1
Crystal symmetry : 17
spatial translation :
0.000000000 0.000000000 0.000000000
spatial rotation :
0 -1 -1
1 0 0
-1 1 0
global spin rotation :
0 -1 -1
1 0 0
-1 1 0
Crystal symmetry : 18
spatial translation :
0.000000000 0.000000000 0.000000000
spatial rotation :
0 -1 -1
1 0 0
0 0 1
global spin rotation :
0 -1 -1
1 0 0
0 0 1
Crystal symmetry : 19
spatial translation :
0.000000000 0.000000000 0.000000000
spatial rotation :
0 -1 0
-1 0 0
0 0 -1
global spin rotation :
0 -1 0
-1 0 0
0 0 -1
Crystal symmetry : 20
spatial translation :
0.000000000 0.000000000 0.000000000
spatial rotation :
0 -1 0
-1 0 0
1 1 1
global spin rotation :
0 -1 0
-1 0 0
1 1 1
Crystal symmetry : 21
spatial translation :
0.000000000 0.000000000 0.000000000
spatial rotation :
0 -1 0
0 -1 -1
-1 1 0
global spin rotation :
0 -1 0
0 -1 -1
-1 1 0
Crystal symmetry : 22
spatial translation :
0.000000000 0.000000000 0.000000000
spatial rotation :
0 -1 0
0 -1 -1
1 1 1
global spin rotation :
0 -1 0
0 -1 -1
1 1 1
Crystal symmetry : 23
spatial translation :
0.000000000 0.000000000 0.000000000
spatial rotation :
0 -1 0
1 0 1
-1 1 0
global spin rotation :
0 -1 0
1 0 1
-1 1 0
Crystal symmetry : 24
spatial translation :
0.000000000 0.000000000 0.000000000
spatial rotation :
0 -1 0
1 0 1
0 0 -1
global spin rotation :
0 -1 0
1 0 1
0 0 -1
Crystal symmetry : 25
spatial translation :
0.000000000 0.000000000 0.000000000
spatial rotation :
0 1 0
-1 0 -1
0 0 1
global spin rotation :
0 1 0
-1 0 -1
0 0 1
Crystal symmetry : 26
spatial translation :
0.000000000 0.000000000 0.000000000
spatial rotation :
0 1 0
-1 0 -1
1 -1 0
global spin rotation :
0 1 0
-1 0 -1
1 -1 0
Crystal symmetry : 27
spatial translation :
0.000000000 0.000000000 0.000000000
spatial rotation :
0 1 0
0 1 1
-1 -1 -1
global spin rotation :
0 1 0
0 1 1
-1 -1 -1
Crystal symmetry : 28
spatial translation :
0.000000000 0.000000000 0.000000000
spatial rotation :
0 1 0
0 1 1
1 -1 0
global spin rotation :
0 1 0
0 1 1
1 -1 0
Crystal symmetry : 29
spatial translation :
0.000000000 0.000000000 0.000000000
spatial rotation :
0 1 0
1 0 0
-1 -1 -1
global spin rotation :
0 1 0
1 0 0
-1 -1 -1
Crystal symmetry : 30
spatial translation :
0.000000000 0.000000000 0.000000000
spatial rotation :
0 1 0
1 0 0
0 0 1
global spin rotation :
0 1 0
1 0 0
0 0 1
Crystal symmetry : 31
spatial translation :
0.000000000 0.000000000 0.000000000
spatial rotation :
0 1 1
-1 0 0
0 0 -1
global spin rotation :
0 1 1
-1 0 0
0 0 -1
Crystal symmetry : 32
spatial translation :
0.000000000 0.000000000 0.000000000
spatial rotation :
0 1 1
-1 0 0
1 -1 0
global spin rotation :
0 1 1
-1 0 0
1 -1 0
Crystal symmetry : 33
spatial translation :
0.000000000 0.000000000 0.000000000
spatial rotation :
0 1 1
0 1 0
-1 -1 -1
global spin rotation :
0 1 1
0 1 0
-1 -1 -1
Crystal symmetry : 34
spatial translation :
0.000000000 0.000000000 0.000000000
spatial rotation :
0 1 1
0 1 0
1 -1 0
global spin rotation :
0 1 1
0 1 0
1 -1 0
Crystal symmetry : 35
spatial translation :
0.000000000 0.000000000 0.000000000
spatial rotation :
0 1 1
1 0 1
-1 -1 -1
global spin rotation :
0 1 1
1 0 1
-1 -1 -1
Crystal symmetry : 36
spatial translation :
0.000000000 0.000000000 0.000000000
spatial rotation :
0 1 1
1 0 1
0 0 -1
global spin rotation :
0 1 1
1 0 1
0 0 -1
Crystal symmetry : 37
spatial translation :
0.000000000 0.000000000 0.000000000
spatial rotation :
1 0 0
0 -1 -1
-1 1 0
global spin rotation :
1 0 0
0 -1 -1
-1 1 0
Crystal symmetry : 38
spatial translation :
0.000000000 0.000000000 0.000000000
spatial rotation :
1 0 0
0 -1 -1
0 0 1
global spin rotation :
1 0 0
0 -1 -1
0 0 1
Crystal symmetry : 39
spatial translation :
0.000000000 0.000000000 0.000000000
spatial rotation :
1 0 0
0 1 0
-1 -1 -1
global spin rotation :
1 0 0
0 1 0
-1 -1 -1
Crystal symmetry : 40
spatial translation :
0.000000000 0.000000000 0.000000000
spatial rotation :
-1 0 -1
-1 0 0
1 -1 0
global spin rotation :
-1 0 -1
-1 0 0
1 -1 0
Crystal symmetry : 41
spatial translation :
0.000000000 0.000000000 0.000000000
spatial rotation :
1 0 0
1 0 1
-1 -1 -1
global spin rotation :
1 0 0
1 0 1
-1 -1 -1
Crystal symmetry : 42
spatial translation :
0.000000000 0.000000000 0.000000000
spatial rotation :
1 0 0
1 0 1
-1 1 0
global spin rotation :
1 0 0
1 0 1
-1 1 0
Crystal symmetry : 43
spatial translation :
0.000000000 0.000000000 0.000000000
spatial rotation :
1 0 1
0 -1 0
-1 1 0
global spin rotation :
1 0 1
0 -1 0
-1 1 0
Crystal symmetry : 44
spatial translation :
0.000000000 0.000000000 0.000000000
spatial rotation :
1 0 1
0 -1 0
0 0 -1
global spin rotation :
1 0 1
0 -1 0
0 0 -1
Crystal symmetry : 45
spatial translation :
0.000000000 0.000000000 0.000000000
spatial rotation :
1 0 1
0 1 1
-1 -1 -1
global spin rotation :
1 0 1
0 1 1
-1 -1 -1
Crystal symmetry : 46
spatial translation :
0.000000000 0.000000000 0.000000000
spatial rotation :
1 0 1
0 1 1
0 0 -1
global spin rotation :
1 0 1
0 1 1
0 0 -1
Crystal symmetry : 47
spatial translation :
0.000000000 0.000000000 0.000000000
spatial rotation :
1 0 1
1 0 0
-1 -1 -1
global spin rotation :
1 0 1
1 0 0
-1 -1 -1
Crystal symmetry : 48
spatial translation :
0.000000000 0.000000000 0.000000000
spatial rotation :
1 0 1
1 0 0
-1 1 0
global spin rotation :
1 0 1
1 0 0
-1 1 0

View File

@ -0,0 +1,784 @@
29 5 5 : number of k-points, lmmax, reduced lmmax
1 0.000000000 0.000000000 0.000000000 : k-point index, k-point (lattice coordinates)
1 113 126 : spinor index, minimum and maximum band indices
2.4333592696949943E-002 -0.10391706203466346 3.2114846364348568E-002 -3.0674154635371920E-002 1.1190493888268357E-003 3.6004993569804957E-004 -6.1317170772742707E-002 6.1168346313394364E-002 4.0186840539431319E-003 9.4269998759664748E-003 -1.7678629790579856E-002 3.0063222671716176E-002 6.0515219337836474E-003 6.9017506134830525E-003
3.2997859951545062E-002 -0.23861551309355550 0.62185072811760156 -0.62457749948256802 1.4301982122558177E-005 4.0630670743654895E-006 -7.0884537273108042E-004 4.0968034059216812E-004 2.8119290826099035E-002 -5.0574987733342132E-002 -4.3912150805835298E-003 1.0979516694963439E-002 2.5247437727067279E-002 2.4255307706471409E-002
-2.0042233940252459E-003 9.4135008428826925E-003 -2.2241433986013503E-003 2.0596233042166150E-003 -2.6343646812998513E-007 -1.2568162510051734E-006 5.1712552941946238E-002 -5.5576553742922953E-002 -5.6645415290659511E-003 -5.7411034519652916E-003 1.5010113205542868E-002 -1.9616505840947825E-002 -7.9851517974476524E-003 -6.9781474147603533E-003
-6.2768522461850731E-002 0.52203855657721276 0.10916430458801685 -9.4952218723001969E-002 0.13438082737219464 5.5244838739985633E-002 5.1594769805584865E-003 5.1646170779129606E-003 5.5540351125593062E-003 -6.5228789644345073E-003 1.5821110666053109E-003 -1.9305843239022815E-002 7.3948291649094874E-003 2.5688598808826721E-003
-1.9767026871361268E-002 8.4426494513562697E-002 -2.6094952282863501E-002 2.4923907921858054E-002 -1.1177681357214296E-003 -3.6005327747597925E-004 -7.0240465340215663E-002 7.0067441465269817E-002 4.6047114315541258E-003 1.0799486561424800E-002 -2.0487605704491808E-002 3.4839956073978738E-002 7.0142582582294897E-003 7.9975662292034750E-003
-0.60015773798531369 -5.0225238992998238E-002 0.13063212040555733 9.9799692804757076E-002 0.14917781334256933 -0.37993231353675305 -0.29689379032611091 -0.46702805110246015 0.15913249010285188 5.3779164048848270E-002 -0.27667727536871395 -6.2534079394356151E-002 -7.1940661470902362E-002 3.5728857045359483E-002
0.12513852393147354 7.9746348301775238E-002 0.28704964953365653 -0.23164717062473977 -6.7587487154241455E-005 -1.6859114705447542E-005 -1.7104135401375415E-002 7.5672602065902286E-003 -2.0136396425954241E-002 3.6421478846619837E-002 5.6917814842243975E-003 -6.0195350807071548E-003 -1.1572242189726606E-002 -1.0108489532150657E-002
2.0143136625700119E-002 -1.4093709163542963E-003 5.6190081478332009E-002 5.8534755764612312E-002 -5.0587431184669941E-006 5.8923237606992029E-006 0.15034076016553266 0.18936102581429157 0.73136288070172273 0.43370852956617872 0.11993897126885023 -3.8737615632849554E-002 -0.27292592743019423 0.33841841737850459
-7.8075550643928376E-002 -0.14865294812718538 1.6108383643151231E-002 -7.0763305860772827E-002 -0.74810026614495873 -0.29327630049948805 3.3793867618790149E-002 -2.2380243419882068E-002 -4.0769470225380904E-003 4.9588246265103268E-003 -3.5069108090157340E-003 9.8094341938945138E-003 -3.2007548474924053E-003 -1.1797772047586145E-003
0.48756181317416869 4.0800640987153976E-002 -0.10613122822342257 -8.1080112729487577E-002 -0.14918756378168316 0.37994391161069341 -0.34009267574694130 -0.53498318114634003 0.18228489440187720 6.1604676179327487E-002 -0.32063572011007363 -7.2469004848039809E-002 -8.3369762902656686E-002 4.1404663513730372E-002
2 113 126 : spinor index, minimum and maximum band indices
-5.6282322693266405E-002 0.46809443153479008 9.7941766070592046E-002 -8.5194523874682376E-002 -6.7170745402635762E-002 -2.7614576207914195E-002 8.1210638226522330E-002 8.1324447688428655E-002 8.7437323663800456E-002 -0.10270920683519705 2.3075093226054961E-002 -0.28162874116914383 0.10787629948790420 3.7480834923068383E-002
-2.2050995825223924E-002 9.4159409281449946E-002 -2.9090082934106372E-002 2.7786441325130459E-002 2.2384499301196775E-003 7.2777290940569865E-004 -4.4602771583595689E-003 4.4499223297158200E-003 2.9556068664006159E-004 6.8446213811127127E-004 -1.4044053665424974E-003 2.3864609031729609E-003 4.8295527142960386E-004 5.4946799827093368E-004
-2.7886324662548343E-003 2.0168759472248075E-002 -5.2558918886347658E-002 5.2790801246952325E-002 -1.2441514213047594E-006 6.4319120707340707E-007 -8.5292315992868111E-003 4.9236206835264109E-003 0.33854606385334357 -0.60893133925010157 -4.8722140745035156E-002 0.12181005001473180 0.28013018392357636 0.26911931372161840
2.3719551111283991E-002 -0.11133335811990938 2.6289486125366114E-002 -2.4353373007942963E-002 -2.0115606982533483E-006 -7.9908643203817960E-007 4.2951281249499033E-003 -4.6167545119727609E-003 -4.7109724916935796E-004 -4.7486847493525208E-004 1.3527708234524192E-003 -1.7659100622083252E-003 -7.2193282863448893E-004 -6.3061604671201953E-004
6.9280247894438249E-002 -0.57619833949094346 -0.12055434028942955 0.10486280293171424 6.7167430060096706E-002 2.7612994245941991E-002 7.0894469158038764E-002 7.0996180960596442E-002 7.6333532529818823E-002 -8.9663218368440906E-002 1.9911022364600597E-002 -0.24301761399168187 9.3086940159402942E-002 3.2342320325181730E-002
-6.9991891131042414E-002 -0.13329769083472218 1.4458028914592870E-002 -6.3476623995084150E-002 0.37396411861334228 0.14661218909485255 0.53204279414503097 -0.35241300582557411 -6.4132261265616941E-002 7.8110377795971422E-002 -5.1194322958924864E-002 0.14309025441656212 -4.6718194381147528E-002 -1.7188845023376226E-002
0.54373996561596494 4.5500379042930597E-002 -0.11829377353847864 -9.0360304115842061E-002 0.29842371215707864 -0.76007767023152650 -2.1595794757791810E-002 -3.3978843801303199E-002 1.1577723221605021E-002 3.9141028792714118E-003 -2.1980097987420153E-002 -4.9666246306067259E-003 -5.7157267997861201E-003 2.8370398685437781E-003
-1.0579362785910724E-002 -6.7407439584551664E-003 -2.4263573722335903E-002 1.9577593287370944E-002 5.3533478041173075E-006 3.1012825732447960E-006 -0.20589857426005251 9.1144768352196440E-002 -0.24249009051560699 0.43848624019828958 6.3181543919253555E-002 -6.6777365717457390E-002 -0.12838049857405953 -0.11217574271697385
-0.23832620050027215 1.6675164448921476E-002 -0.66481784592625193 -0.69252907129783225 2.1698704979145056E-005 -6.4292542784061268E-005 1.2483576705380139E-002 1.5730935008839389E-002 6.0745740016948616E-002 3.6019864775594115E-002 1.0810812815807803E-002 -3.4919961582805595E-003 -2.4597116201494847E-002 3.0501640631583636E-002
8.6150186679047294E-002 0.16407859642336051 -1.7800672021970453E-002 7.8128072014173169E-002 -0.37395193417210365 -0.14660155459566629 0.46446122929141975 -0.30764780351681176 -5.5985450456570274E-002 6.8188574027334733E-002 -4.4175720508917070E-002 0.12347238227129834 -4.0314532024666609E-002 -1.4833014929708796E-002
2 0.1250000000 0.000000000 0.000000000 : k-point index, k-point (lattice coordinates)
1 113 126 : spinor index, minimum and maximum band indices
-0.39393200174511189 0.15248976315349119 0.22505415296926456 -0.13133898045060652 7.0753782647128990E-002 0.25298655868699116 0.26038426119608798 -0.19214021581878227 0.31377751754281386 -0.22699501770996472 -0.12191837672150749 0.15455703435042703 -4.1107699774964403E-002 0.15047125683164661
0.42287343134117822 -0.25709235564586869 0.55201664931520722 -0.21786920336377075 -3.7065486915017071E-002 7.6580824103435891E-003 3.7987921706307826E-003 1.6789237439095921E-002 3.8056649445772542E-002 -2.0495315733386105E-002 -3.8804404481933025E-003 6.9432248900925852E-003 1.5875629078972185E-002 -7.1239097252438228E-003
2.6715193684894795E-002 2.7015415712490224E-002 3.1862949459859499E-002 1.9409078973310727E-002 -2.7233057170729753E-003 6.7548308351910594E-003 -0.36458708661794953 -3.5389658685164131E-002 8.9205727410178501E-002 0.40834955244751109 0.14833742515871048 8.5932144101111704E-002 -4.9560927377803800E-002 -0.16072520554871489
0.19051600882499015 0.35929325490108860 -0.16678437521042733 -0.36759017411805500 -0.30565670972339243 0.16524097724218223 -1.8581498245687191E-002 -1.4136613800897719E-002 -2.3711997256332395E-002 -2.4289880455134433E-002 -1.5179840388091234E-002 3.9917628617634924E-003 -1.7919559178469387E-002 5.2373318434575621E-003
0.32120945381355670 -0.12069395336903430 -0.18763403768529036 0.10491834975777453 -6.6389453185357369E-002 -0.25362232160280340 0.28265403082686341 -0.22586875683083957 0.37163357047077122 -0.25602292990289177 -0.14088002505522249 0.15740935704677364 -3.0212543412518299E-002 0.18769784167264861
-0.11206305355255959 0.10293934033247402 0.33519898750755633 -0.13441313136677169 -7.3694776344856536E-002 -0.30392454868808561 -0.25262315562428755 0.11199952720388104 0.14447878920568538 -6.6094104400879830E-002 -4.9142872817108888E-003 2.0318775297113491E-002 -2.8182049874761379E-002 -0.11249656729464719
-0.40632264464305967 -0.28860807891548723 -6.7669660735595091E-002 -0.37416236561941030 -2.3253243537034229E-002 -2.0059510581847281E-002 4.4195252694808271E-003 -3.8933493780699963E-002 4.8852850745953989E-003 4.0851506681344449E-002 1.1024046954689993E-002 6.9483494533480530E-005 -8.0722016751162591E-003 4.0022163111997730E-002
-1.8821698808396282E-002 4.1580923278879710E-002 2.5207007463323495E-003 4.0548351304252044E-002 2.8417226555226566E-003 4.3083626817433072E-003 -0.45342501270517166 -0.24523146809117730 0.48475789519618201 6.4948115474175727E-002 -2.6453255611008164E-003 0.23430734623233024 -0.21544322820284920 -0.14327165097690001
7.6553234895290478E-003 -5.0977652879638860E-002 -3.9793412970105989E-002 -2.5231865604668280E-002 0.70982986553717753 -0.19762047343127165 -2.9104138857450152E-003 -8.1199964636235831E-003 -1.1252326465433539E-002 1.1354560498210028E-002 -7.9632547250843809E-003 1.2613976173671474E-002 -1.6904583800616688E-002 4.6428789468135299E-003
8.9113730242429842E-002 -8.7328246159390346E-002 -0.27557613917991391 0.11401170216185094 8.4949677741435567E-002 0.30026993794325463 -0.27647667839033069 0.12845192159728192 0.16147429103838709 -8.7730826661756481E-002 7.9176367267212687E-003 3.1398524629019424E-002 -3.7033411120030356E-002 -0.14476547390195099
2 113 126 : spinor index, minimum and maximum band indices
0.13734954558854873 0.33304269034360268 -0.15129519543895628 -0.33253404123542624 0.16296703293199585 -4.8396352447139017E-002 -0.25371178993948995 -0.35193413520095684 -0.27027127306425064 -0.40186411174104808 -0.15691060312304489 -0.14088213601344651 -0.18155010773029592 -3.1718410816391047E-002
0.33831924105415612 -0.18730561940729418 -0.20627596232843765 0.11809300657994626 0.10797650886260714 0.51094415891280276 1.1093111805993929E-002 -1.6900946803588602E-002 2.0134235271961693E-002 -2.5914990488264716E-002 3.8412947093721369E-003 1.5103789040249598E-002 5.4403450888436825E-003 1.8607989752723847E-002
-3.5755869225754765E-002 2.1736109588768156E-002 -4.4814165992613932E-002 1.8174396892674492E-002 6.7845825769617951E-003 -1.4019042036011497E-003 3.8837914066862225E-002 0.21384825967259208 0.41016943787117716 -0.22132194522550147 -8.3165806271183834E-002 0.14825399079302903 0.16646439110851810 -5.8471597570616270E-002
-0.31599279881913700 -0.31950115017351333 -0.43296236288899786 -0.21844563661598998 1.4863011413509750E-002 -3.6870988390399401E-002 -2.7584854098365155E-002 2.3197992539623928E-003 8.2365629448486327E-003 3.7889466459076482E-002 6.9646049575565550E-003 4.0222468691339863E-003 -5.4486477771397502E-003 -1.5529026544609671E-002
-0.17185538451460447 -0.40907659848059574 0.18220789960782488 0.40288803892425057 -0.16654120251845042 3.6354723453741154E-002 -0.21662734257405761 -0.32358294630664786 -0.23634702547127490 -0.34157277864162972 -0.15420678574058710 -0.12179720146721533 -0.14570097941863600 -4.2247666761353712E-002
-5.7612678542624890E-002 -1.3793852512249124E-002 -3.3547433970054025E-002 -2.3991661985289590E-002 -0.35767503258773348 9.6340242931931080E-002 -5.5968747308044915E-002 -0.18074035451110188 1.2182174811359506E-002 5.0692451369341571E-002 3.3085383232663565E-002 -6.4056720508070524E-003 -0.15261150014687525 3.5737851043476085E-002
0.13129342477135841 -3.5857874130372974E-002 -0.30528090777325889 0.12426349533285327 -0.23387670422793433 -0.57985023324333895 -1.1922150074165668E-002 8.2710066727702865E-003 1.7713434728253447E-002 4.1358342325874186E-003 -1.2658240649004192E-002 -8.1226298374664392E-003 -4.4153632198270544E-003 -1.6135638492160539E-002
3.4353699696769824E-002 2.4402082328248979E-002 3.5554152928361201E-003 2.6294794543110078E-002 4.2649945839357516E-003 3.6764791583800294E-003 0.24495130548165431 -0.54086585481291116 5.2245891537704578E-002 0.44056286922596472 0.23535273406361870 1.1065200619173397E-003 -0.13637657763224398 0.21333330519451041
0.22259287645580028 -0.49177081324169181 -6.3597573354623460E-004 -0.51145208894078387 -1.5505756140821184E-002 -2.3555756354482038E-002 -3.2225714889317802E-002 -5.3229217295848105E-003 4.4947276931234362E-002 5.9871463062439985E-003 -1.3374092567234892E-004 1.0974548777206099E-002 -4.0278094275295107E-002 -8.7312933516589912E-003
6.5587616969956283E-002 1.9616267626866444E-002 4.6166459329210013E-002 2.6439745383066281E-002 0.35866240612266564 -9.5472534212834442E-002 -5.0222434044539598E-002 -0.16450579138148286 -4.1844211084610117E-004 5.0603277487274334E-002 2.1995532493450556E-002 6.2152366350281818E-003 -0.11880730625663871 2.6442720509391907E-002
3 0.2500000000 0.000000000 0.000000000 : k-point index, k-point (lattice coordinates)
1 113 126 : spinor index, minimum and maximum band indices
-0.39952178976683839 9.0982224113377308E-002 -0.31320676169999240 0.14085245903560786 8.9976563291885095E-002 0.24520575793953531 0.36794561947869675 -1.0505301246426554E-002 3.9971559067289594E-002 -0.21331790124579741 -3.8464631498000709E-002 -7.4343815319101614E-002 -4.6340896140260081E-002 -0.11623243979816664
0.28580387250909917 -0.19332880568101313 0.10020737866707499 0.37393770201640486 -6.7633210312162184E-002 3.3904323549507759E-002 2.0406402721613183E-002 1.3032107420891212E-002 1.8396697629397628E-002 2.1723156048673958E-002 -1.9291983181393947E-002 9.1263408837615641E-003 1.6264182069825855E-002 8.0544723083652847E-002
2.3648841639384133E-002 3.4953759397678030E-002 3.2586459718287226E-003 -4.0473837116095125E-002 -6.2753425154968507E-003 -1.2505693944307075E-002 7.8670877120398275E-002 0.17560360659105670 -0.36660099770180171 0.31107257337383387 5.5772856600839395E-002 0.11805111565205970 -0.12764498577271949 6.5794752163593997E-002
0.23413352841752505 -0.15830263825505375 -7.1385320744733194E-003 0.32363977263267629 -0.32369442073330063 0.16236971915848938 -1.3711791042804245E-002 5.1956386227678363E-004 2.6752196416100649E-003 3.1192509414051418E-003 -3.6046033648369544E-002 1.6999127432070250E-002 -1.8574035782167382E-002 3.1058654071359007E-003
0.32513109644711213 -8.2274433432870719E-002 0.25849956808134844 -0.11502699949718490 -8.1448657967053431E-002 -0.23671610430070295 0.36538121362681331 -2.7496207673707996E-003 6.9871813432604027E-002 -0.26201630221802019 -1.3076349675871991E-002 -1.9234557694065513E-002 -0.12492940681234760 -0.19870412951420127
3.3545401667134586E-003 -0.18149506702933102 0.27090469843945275 4.6015763380090537E-002 -3.9432687200586437E-002 0.31021758430002605 -8.7898749934683384E-003 -0.26126648626849869 0.35014355885295589 0.15097350983234839 5.3181134960198495E-002 -0.11759074648588791 4.1172317912081952E-002 -4.8519297140020970E-002
-0.50100736499829646 0.33895535357515594 0.52873196699174074 0.24318122418785709 -4.7953993701904285E-002 2.4103893051898265E-002 -1.1717869928358150E-002 2.4882525805330933E-002 4.3062231061532924E-002 5.0699283998975338E-002 -2.0571436536451389E-002 9.6993240967658371E-003 -4.4030030274043404E-002 -4.0373178993677553E-002
-2.3635465753832640E-002 -3.4944193446291905E-002 2.7808246201786048E-002 -1.7510881870145531E-002 6.2773576952171025E-003 1.2495711265725042E-002 -0.61087221719757911 0.12665900476967862 0.36728661947335717 -0.31116824329435711 -5.5646948340139085E-002 -0.11809649210231089 0.18597033953058142 0.12207112683049960
-1.3417079145356670E-002 -0.30780989510347034 -0.13631614601190017 -0.19816580485089424 0.68348528715682222 0.22521658492628055 -1.5826325302687048E-002 3.4934964640214693E-003 -4.2522003270557010E-002 3.3807011649159620E-002 7.9654379721734135E-003 -7.0874146632313006E-002 3.6870729915339497E-002 -4.1531734090345274E-002
-7.5924188770758738E-003 0.14275442390386953 -0.22867679238019695 -4.8869061015350483E-002 6.4695215005224002E-002 -0.31011708911275443 -1.5288437704407336E-002 -0.30234326613461793 0.42037895146239090 0.14974489500720725 9.4140291266683607E-002 -6.9807958195250180E-002 1.3493552392632212E-002 -4.4058940098648469E-002
2 113 126 : spinor index, minimum and maximum band indices
0.11600131801309319 -7.8398458840841234E-002 -1.2293302837043996E-002 0.29542395030322804 0.18162362063871110 -9.1106490464098508E-002 -0.15027545580710019 0.32319564855534566 -0.18757694868413477 -0.22099157208012216 -2.1414595140401702E-002 1.0060651504091059E-002 -3.9407713924302881E-002 6.2486634412008128E-002
0.33865735871042746 4.8782326819282462E-002 0.28575530978908964 -0.12795455686521889 0.12249663289167299 0.43324889178148168 -1.3235667190151410E-003 3.8489052713615492E-003 -1.5450700580167023E-002 -1.3311296619449889E-002 -1.4767764920445813E-002 -3.5769948772944891E-002 -3.9303220342596590E-002 -4.1241222873620746E-002
-2.4491660065790118E-002 1.6564810493814246E-002 -4.6260143641380525E-003 -2.5568017380522400E-002 1.4417457475507685E-002 -7.2350818640620033E-003 -8.7651524004589698E-002 0.37641160660545664 0.17322638670413767 0.20409408881322907 0.11437847744691654 -5.3859383992527245E-002 -8.5362912659876472E-002 0.22158706372825612
-0.27600853040762741 -0.40791956759524350 -0.12045754443518847 0.47468750555354561 2.9409245363159017E-002 5.8674733780390953E-002 -1.3259607551083556E-003 -2.3538920416415324E-002 -3.8995833839945489E-002 3.3069314128609056E-002 -9.3796681241379853E-003 -1.9933200595335293E-002 -6.9313885718481252E-002 4.6861778293871607E-002
-0.15107454774395748 0.10209913910310436 1.8580863045559353E-003 -0.35206209273532313 -0.18997632169847092 9.5298139959911612E-002 -0.12283826483547404 0.32210976172980033 -0.14191151699557986 -0.16714848129804377 -7.7978657315232749E-002 3.6726613427539807E-002 -2.2249881657880020E-003 5.6359502851769973E-002
-0.11699733301758534 -0.31562429320681912 -0.12437884778117034 -0.17844180014141947 -0.34528638080217028 -5.0188123330531631E-002 -0.26236904434229569 -0.17131607900747797 -0.23636181673661069 0.36431188180137231 6.9031164976897291E-002 9.4429474633626581E-002 0.19973583812641327 -0.10905026723049008
7.1547162542314385E-002 0.22940051877855389 -0.24969955534073240 -4.7504695838124181E-002 -0.24915869242776595 0.61986299271055822 -3.2781963811382205E-003 -2.0588116564425354E-002 3.0228397463598868E-002 4.0469954447078904E-002 -7.1347002274048638E-002 -9.1219041362272692E-003 -1.3862398468276131E-002 2.2458172633737761E-003
4.2929148805730143E-002 -2.9043075626248895E-002 -4.3857029826480182E-002 -1.1411930381134337E-002 1.0234119706321661E-002 -5.1397772299463605E-003 0.19808136801193985 0.48742883023379524 0.40446085314065933 0.47715918345276997 0.12167472690875028 -5.7329905678705793E-002 -0.10925033941493315 -4.2407108019292136E-002
0.27584567348437306 0.40778912968246900 -0.42948360550717279 0.25351137719664696 -2.9430610123851050E-002 -5.8572156382964979E-002 -2.8065659303849584E-002 1.8697918055587265E-004 3.9005420530170108E-002 -3.3142814878274723E-002 9.3741610060339361E-003 1.9920151827743891E-002 5.7580237833122667E-002 2.7563873966134204E-003
0.13560951776758809 0.38626603356863959 0.14817742387114444 0.21804545792091223 0.34680188667667960 2.3855341902299057E-002 -0.23082698326993309 -0.17821966232139463 -0.21941196966738832 0.31019907484136200 0.11511651930508041 5.4339181471389213E-002 0.12600742089724304 -2.5938958579977689E-002
4 0.3750000000 0.000000000 0.000000000 : k-point index, k-point (lattice coordinates)
1 113 122 : spinor index, minimum and maximum band indices
-0.39941605362771060 -9.1874313702454607E-002 -8.5726734810784716E-002 7.5707469650250658E-002 9.1253010367938911E-002 -0.25316280465934587 -0.35871587616550432 -9.8373159441090471E-002 -3.1637034094507951E-002 0.23532458051124081
0.25845285326232592 0.17412387278950767 0.35586531816081568 0.40899711403480787 -7.8008073987786808E-002 -3.7323862280813060E-002 -1.7715953554571021E-002 -5.5356018782635056E-003 -1.6303653829379084E-002 -1.9016427797844560E-002
2.6600664387435691E-002 -3.9446822621497825E-002 2.9232082834298916E-003 -1.8960098851782872E-002 -1.0626783009557730E-002 2.2184948220055959E-002 -0.11634947585146517 -4.8558000074504504E-002 0.37732309492313415 -0.32399545962826370
0.24797109504778145 0.16717976947776311 -9.0195298365332716E-002 -0.11397219648800785 -0.32570634640800283 -0.15600678490416120 1.3245099409809667E-002 -5.6307213267548983E-003 7.1375117573228061E-004 8.6022612603700241E-004
0.31653785983540783 8.2878504676442533E-002 6.8630217413978151E-002 -9.4904296909366609E-002 -7.6556790600596183E-002 0.23793803945616346 -0.36921281357231456 -0.12054647353314714 -5.5529088778002333E-002 0.28408848603580189
2.3134722608275104E-002 0.19293336147848866 0.41108912829901439 -6.5271006218919667E-002 -2.8982874185467800E-002 -0.31074852968262145 1.6675752207450056E-002 0.30352258776092900 -0.36018068649761148 -0.14574598453611004
-0.51531139405284043 -0.34748289515877995 0.37431881470337053 -0.25382421503648755 -5.5414346425453898E-002 -2.6582155709369851E-002 3.9203147543691152E-003 -3.6797548341236982E-002 -4.3892424036035688E-002 -5.1079641509509922E-002
-2.6592975006154384E-002 3.9457568813966108E-002 9.7407137305956758E-003 3.5464267510644756E-002 1.0628845075034934E-002 -2.2179585052326457E-002 0.66654060400308890 -0.19235678692285152 -0.37809333774453802 0.32414301370201570
-1.8208854273507075E-002 0.29543648707943115 -4.5850173641012626E-002 -0.37782389432625962 0.68052092702507827 -0.24570136589266500 1.8890445969942854E-002 -3.4542132810362995E-003 3.7567447692922348E-002 -3.2861694043924992E-002
-2.4545526250838671E-002 -0.14701531557743086 -0.36320451800432846 4.3280006396770127E-002 7.3392145233695014E-002 0.30975043803453683 2.4736708721931237E-002 0.34391437009438663 -0.42865360606917857 -0.14876803976062608
2 113 122 : spinor index, minimum and maximum band indices
0.11339560423170914 7.6465360254192524E-002 -9.8621722939463308E-002 -0.10319605886099852 0.18311765865737134 8.7695548062459688E-002 0.15785356093446151 -0.36975338614616138 0.19646443031436275 0.22868757836309478
0.33306965885570788 -6.0865734017899187E-002 7.7171514983773060E-002 -8.5366413694017262E-002 0.11298035921628022 -0.43433081230330772 -5.2075038393200896E-003 -1.1076897739844528E-002 1.2877796421494841E-002 1.6268803043880231E-002
-2.5014434966950081E-002 -1.6854818030663063E-002 -2.2277270870982729E-002 -1.9741373843213360E-003 2.5565198322563962E-002 1.2246385736285323E-002 2.7006658891579566E-002 -0.18947570072252062 -0.15989772950421219 -0.18610239878108675
-0.27491127697021184 0.40759071060960977 -0.43148628500209329 0.31828337021253100 3.2387875816675370E-002 -6.7704457353378683E-002 -1.4211475741835278E-003 1.8046004556481976E-002 3.8525458979964941E-002 -3.3072481713651770E-002
-0.15413859390028761 -0.10392374008671988 8.1626340492218286E-002 0.12481085345819092 -0.19796352587060617 -9.4803453682530819E-002 0.13134545910710643 -0.35841781865483791 0.15337590544204602 0.17849577032868680
-0.12498499365181520 0.30813965944968330 -3.3972461849086068E-002 -0.35493592694663201 -0.34500734850696108 5.9637823299806485E-002 0.32848042190035692 1.6255498049683278E-002 0.25340564662106102 -0.36673545808447922
6.5551037595414696E-002 -0.24108275076764391 -0.38701396817626543 5.4292943988300618E-002 -0.26821985615741889 -0.61689039789035016 4.0565246875686953E-003 2.0240262429125126E-002 -3.0245099077030164E-002 -3.3867708914825767E-002
4.9870975726706082E-002 3.3626054740131042E-002 -3.3481674790213488E-002 9.9772873543536658E-003 1.8182768641266809E-002 8.7120562918995524E-003 -0.19661136656709277 -0.64950658893879420 -0.42950903290565789 -0.50071640065788214
0.27475693521431027 -0.40769027237387528 -0.21337088953711303 -0.40675076651496089 -3.2423179372963254E-002 6.7614546788866303E-002 3.7189106751955650E-002 1.9401142475910793E-003 -3.8553556939648244E-002 3.3137828768521282E-002
0.14799292351473003 -0.38634987874467702 5.7707191596267339E-002 0.40096032063559317 0.34852215385879420 -1.3402644487301295E-002 0.29078679247203282 2.3110054792837037E-002 0.23038397347963521 -0.31438964042087630
5 0.5000000000 0.000000000 0.000000000 : k-point index, k-point (lattice coordinates)
1 113 122 : spinor index, minimum and maximum band indices
-0.39978771584235023 -8.7591019689209515E-002 0.16016848436082554 -8.5496439021759074E-002 -9.9359289805151532E-002 0.24949885988524168 -0.30884474228313413 -0.24099425253179946 -4.0111732117102415E-002 0.22949257455968428
0.25225711362961334 0.16682162378699339 -0.24588317555298284 -0.47351019272248707 7.4687542516314487E-002 3.5508990259454823E-002 -2.2816176710273181E-002 1.1838024720674798E-002 -1.6945095316236926E-002 -2.0788724421723623E-002
2.7080765223982579E-002 -4.0908021400575020E-002 -9.0668150782829728E-003 2.4858194595101191E-002 1.0842383773875497E-002 -2.2779485216843934E-002 -0.16345036223320022 0.12778792426493232 0.38516954745431281 -0.31448642473003119
0.25124674572802574 0.16627872419759987 8.9509796722581358E-002 7.8417860172798198E-002 0.35250763548597230 0.16777929959213911 1.2591073802734706E-002 -2.5651755472612392E-003 8.0249349194586386E-004 1.0278085262238074E-003
0.31456550164236324 7.9254853885909471E-002 -0.13335729752495196 9.9137072408806232E-002 8.6499083942039798E-002 -0.23281425678332279 -0.31929943332251515 -0.28131442949657331 -6.6278006498971601E-002 0.27850395011049106
2.9471591606756171E-002 0.19643062467148317 -0.39594327347803571 1.7015264755707946E-002 3.0358617593199098E-002 0.31123392873207290 2.4254544372684594E-002 0.27059974873901710 -0.35671824708913669 -0.15591717263594318
-0.52183613742569612 -0.34542237600132175 -0.42597232466295909 0.17865952038038774 5.9978388043854303E-002 2.8587203763422150E-002 1.5355518780374444E-003 -3.8189012661766414E-002 -4.3698998497461790E-002 -5.3489118548498069E-002
-2.7070881469161673E-002 4.0919330120842812E-002 -1.0607790378077384E-002 -3.6332773879207310E-002 -1.0844616912599667E-002 2.2773585249462741E-002 0.65932230965669480 -0.13603351891056303 -0.38634593212886009 0.31464778926453929
-1.9191393455882333E-002 0.29299827705962855 2.4137333599730304E-002 0.38871380226382130 -0.65986503349796033 0.25687641623534541 2.2283402455783106E-002 -7.3049122136164997E-003 3.9372761171080371E-002 -3.2892602119918152E-002
-2.9596486322494134E-002 -0.14845960008640566 0.34109363410887306 1.6226576429698054E-003 -7.6202178017798494E-002 -0.31024223843459175 3.5712001090168657E-002 0.30200106210162564 -0.42737714101212088 -0.16115590710910083
2 113 122 : spinor index, minimum and maximum band indices
0.11411523043034004 7.5537369697134454E-002 9.7824911747382629E-002 7.0147218524984192E-002 -0.19797988113865653 -9.4216805362633410E-002 0.14428068241652894 -0.28137553298401324 0.19003699948985825 0.23262552732997810
0.33139219104643586 -6.4529171491852499E-002 -0.14674147407376276 9.2375169278937505E-002 -0.13908509228038352 0.42164641739715936 -5.1585836674224953E-003 -2.0165346218910273E-002 1.2293290932333228E-002 1.6580853354896168E-002
-2.5183160762251629E-002 -1.6655844798518477E-002 1.7951511876918916E-002 1.0818563916897393E-002 -2.5104541739754800E-002 -1.1949355372766446E-002 -6.5932950811580793E-002 0.10122891313684387 -0.16126460254930028 -0.19729189082305587
-0.27132623012853146 0.40979484861306609 0.43388445677301429 -0.31817234654294402 -3.2220926519055608E-002 6.7777278799005469E-002 -3.6691561483023997E-003 2.0495165511278439E-002 4.0547314080348153E-002 -3.3094748283020108E-002
-0.15667319876412442 -0.10369167571381144 -8.1068878295873739E-002 -8.6705598926772445E-002 0.21445933703662570 0.10205613514836234 0.11904923217706452 -0.27609519672710731 0.14728477608365820 0.18024307828194719
-0.12368066249988181 0.30679002691421364 1.6156038266923467E-002 0.35945832552225665 0.33355446954307605 -6.6422293982840053E-002 0.38672068980996072 -0.15526609096204158 0.25959354876373841 -0.36453081877932469
6.0632173991267996E-002 -0.24358434622739805 0.36838782859809582 -7.7191127907359491E-003 0.27347754463473950 0.61798144536288169 5.7674938908290514E-003 1.5763239714651409E-002 -3.0526785278865837E-002 -3.5718987631364857E-002
5.2092219675528906E-002 3.4479039269548165E-002 4.0197445287457965E-002 -8.8138913331767092E-003 -2.0183554990695417E-002 -9.6102023615059380E-003 -0.17464814574514806 -0.67166993386990304 -0.41460121466363098 -0.50864423489591726
0.27116809059500213 -0.40989301329751321 0.26053577021061347 0.37506299428444367 3.2255870974807352E-002 -6.7686777109628560E-002 3.9817011848794465E-002 1.0159254587759082E-002 -4.0606951309250593E-002 3.3181995725497196E-002
0.14733353793652573 -0.38722735769462024 -3.2052691990451618E-002 -0.41822359310809976 -0.33634001386705742 1.9458190000315546E-002 0.34227013681984347 -0.14066724161492822 0.23507580348589921 -0.31037247338758089
6 0.1250000000 0.1250000000 0.000000000 : k-point index, k-point (lattice coordinates)
1 113 126 : spinor index, minimum and maximum band indices
-3.0410109498192402E-002 5.6987904661959153E-002 0.29070303547875642 -0.26432100033100803 -9.1347059623907538E-003 2.1254832485656346E-002 -0.12533438974990690 0.17013391348124254 -5.4302195596736887E-002 0.15536209025355935 1.7454108862754707E-002 -1.7906345914513094E-002 9.9709911163559428E-002 -5.1515483354118027E-002
-1.1974612918586435E-002 2.2574001722030244E-002 0.50619557690851957 -0.46011283577758944 3.0801083075633097E-003 -7.1942046808060323E-003 3.2816089620826480E-003 -4.4560675318623694E-003 9.6867450772273826E-003 -2.7712132016228300E-002 -8.8481626779955969E-003 9.0801910338401699E-003 -2.6355403729414910E-002 1.3613356313269116E-002
-6.0577632818143391E-003 1.1367010514349334E-002 -2.3483625905768673E-002 2.1365401203766538E-002 -6.3631283182240966E-004 1.4803282849803266E-003 -0.10498748118018127 0.14251689554531216 0.15819046050695174 -0.45257709884968039 1.0555477066636827E-002 -1.0853015553854794E-002 -0.23038934354105461 0.11904544266029420
-4.1106445795881727E-002 7.7203839363492233E-002 3.3889859491396279E-002 -3.0878664053498012E-002 -2.1113282489826569E-002 4.9246831639902303E-002 1.6144314904599066E-002 -2.1916370270235824E-002 -3.7149236666786903E-003 1.0630664055182464E-002 5.6201172264811533E-003 -5.7698352584846218E-003 1.1708084745119406E-002 -6.0467653127653058E-003
2.2819643067172803E-002 -4.2755318338441671E-002 -0.24871096459809874 0.22614080611097231 8.9308162296477464E-003 -2.0778673334347287E-002 -0.14476864560226005 0.19651236434253608 -6.0267798202512025E-002 0.17242762068512596 2.0683703698817110E-002 -2.1218230777654529E-002 0.11435311624484937 -5.9081454719682694E-002
-0.53154171499488956 -3.3160944185124296E-002 -0.10570317025469236 -2.8978161362581634E-002 -7.7864318763363458E-002 -0.32827545590332130 -0.11305562185727772 -0.49030916989435502 -0.25058451022549705 2.0136753040215442E-002 -0.14650919968165557 1.3230721009101177E-002 -4.5028868528993328E-002 -8.0186562193290359E-002
0.44607694464613512 0.33660903652883922 0.19943022623426021 0.37132635366820388 -0.17092704086737859 2.6377566006280967E-002 -4.3933894315862927E-002 -2.1705422437724272E-002 -2.8940525404566181E-002 -2.9329092671358803E-002 6.6880264838035483E-002 -1.3930383548592808E-002 -1.2153417168849290E-002 -2.5363595804561767E-002
-3.1480838904484373E-002 3.3096569683294989E-002 3.7999033121488321E-002 3.4742777461841054E-002 2.1806859878319308E-003 -1.9613048620939901E-002 -0.11981484073895142 -0.42922811163908303 0.59997404281952726 -0.10409313290046392 -0.13214067691044371 -3.4353096844176027E-002 0.13388642248205782 0.24304167727929682
0.15231764687525118 0.41980374852782065 -0.16331599913722727 -0.16944122905331094 0.77615510326072790 -0.34969483967657433 -3.1685963176613853E-002 2.9090306303784345E-002 7.8110777657110636E-003 1.0100548677743529E-002 -6.5775191784788981E-002 -1.3855227101191827E-002 6.4314187585329859E-003 1.3265623520537178E-002
0.43067237149991833 4.1863469286135900E-002 9.2253477875989059E-002 2.6791282138105617E-002 0.10440108241796724 0.33306158442676947 -0.12840559168703591 -0.56472855353365492 -0.27908721966813826 2.2007950058283453E-002 -0.17425570541656119 1.5044045454937557E-002 -5.1586119835810608E-002 -9.1852632836722917E-002
2 113 126 : spinor index, minimum and maximum band indices
-5.2790515063809856E-002 9.9108269619673187E-002 -5.9972663459583742E-002 5.4430842479402317E-002 7.6151867294751404E-003 -1.7775822601561134E-002 0.14088564911839266 -0.19125203997915829 -7.1918340206494041E-002 0.20573788561747361 -1.7430368323728990E-002 1.7861965945869935E-002 9.3506429913863223E-002 -4.8302462741148758E-002
4.3856033910203117E-002 -8.2251723272096164E-002 -0.17213714652108550 0.15648545791821397 -1.9330265511150184E-002 4.4967150595375170E-002 -2.6544975511088960E-003 3.6011133312133705E-003 -3.0039430377862518E-003 8.5966882128952152E-003 8.6565394764038968E-003 -8.8743843928599537E-003 1.3086621327061877E-002 -6.7619932392745082E-003
1.6109126407117152E-003 -3.0309707003261708E-003 -3.7521946634071164E-002 3.4106543462138393E-002 -1.9150707126052181E-004 4.4922753885065974E-004 0.11282819465142950 -0.15316833667476509 0.14934437425194777 -0.42724952401892302 -1.8070653256163936E-002 1.8537047665951080E-002 -0.24634362632481963 0.12725903045928358
7.2924015809007092E-002 -0.13682507183281006 0.29914404375614623 -0.27216518089055508 4.9279573671994897E-003 -1.1466385357539105E-002 -1.5506558447025490E-002 2.1050048051693006E-002 1.0385824809120661E-002 -2.9710151923504839E-002 -5.8211559467311203E-003 5.9631607035401830E-003 -2.4963525677287143E-002 1.2899545658160861E-002
6.4004152093499633E-002 -0.12016262501031925 6.7785526677749314E-002 -6.1519465677350033E-002 -6.7325828182814530E-003 1.5721442402525220E-002 0.12272779900083350 -0.16660149435478427 -6.4537440302514348E-002 0.18462600521477243 -1.4593336673375264E-002 1.4952748340706836E-002 8.1627625347689262E-002 -4.2167436738844849E-002
-2.8165012643463744E-002 0.41972454534717618 -0.21969301836182736 -0.25962962534723533 -0.33362528920538653 0.10326168762121156 -0.58111338742296981 2.9462693964115660E-002 0.15825477338468660 0.19796701329485719 -1.9311289482672932E-002 -0.17455591334838039 5.6446726651947825E-002 0.11577059269974543
0.42459053724050932 -0.13463659128712385 -5.4591980274475427E-003 -5.7683957778331213E-002 -0.35261501263957667 -0.77514058250175477 -3.6323655825401424E-002 -3.5378328687638905E-002 -1.4350435594520417E-002 9.4471609833543567E-004 -1.2262586208191772E-002 6.5415699398339411E-002 -6.4252888802486521E-003 -1.1519863402947382E-002
-3.4955984729746238E-002 -3.1915480777346142E-002 -1.5986415411302541E-002 -2.8848938501374207E-002 1.9668349029923253E-002 2.2251688255299803E-003 -0.43796248222862760 4.3801063333933930E-002 -0.43973229461175162 -0.44994382145524275 3.1152703252179118E-002 -0.13127202561757367 -0.11207076546627626 -0.23410154101689640
0.32937391998331778 -0.42475532103556807 -0.50999647274866078 -0.47110052067387453 2.6888732745789790E-002 0.17057155003120061 1.5826587538121387E-002 -3.8702401470973813E-002 3.8991170703496836E-002 -6.9718161894607184E-003 -1.5575401959676927E-002 -6.7199654417049753E-002 1.4334139676445305E-002 2.5997652586370400E-002
1.5813975067441415E-002 -0.51866365681274562 0.25713245916305832 0.30315171816117104 0.32889565496469547 -7.6802828699167727E-002 -0.50427211421316909 2.7093351608154681E-002 0.14275276461625117 0.17791154191239875 -1.6819079538471074E-002 -0.14677512239728147 4.9215753854016657E-002 0.10094664249886395
7 0.2500000000 0.1250000000 0.000000000 : k-point index, k-point (lattice coordinates)
1 113 124 : spinor index, minimum and maximum band indices
0.49284418199310576 -9.2399888859156551E-002 -0.19110538838541458 -0.24022205736131630 5.5596882394500308E-002 0.34556478406409008 -0.16732833646744075 0.11345472306895693 0.26256942103404901 0.19171765895250589 7.5823884490688526E-002 -6.8975886832683450E-002
-0.56432033230226208 -0.12844868709991378 -0.31568832232227284 4.9672784359959601E-003 0.13698227449475475 2.3706502902981486E-003 -2.2866019356347682E-002 2.7527229547238734E-002 2.3710387525848486E-002 -1.5667764924314442E-002 -9.1474859027559377E-002 2.1096056047721964E-002
9.5625867718743332E-003 -4.2059097430293998E-002 4.7134036856011273E-002 2.9407579717420928E-002 -4.2471160471475302E-003 2.2526803631651573E-002 -0.14556638408657138 0.12240487679385605 -0.63337794242598700 -0.53293773424565505 7.2185960400017901E-002 0.15235223135597153
-0.23527799077723599 -0.35620727861701862 -0.18679173017515971 -0.12351888567121175 -0.71924814077191701 0.35249659102643627 -1.7362124022465373E-003 1.1427606478910680E-002 -3.8713143165378973E-003 1.0166790323636751E-002 0.10408417010256292 6.1501953061237841E-003
-0.40208421519140314 5.8630222151874176E-002 0.16268334794635181 0.20625608465886908 -9.3079030709639937E-002 -0.34722979076826199 -0.19350548134354076 0.15201817067846757 0.28800725745485778 0.21194785034693389 0.11509303873960847 -7.4501576822696133E-002
0.14488366813405379 -2.9605179349844704E-002 -0.10379504232546351 0.24781169314348395 3.0774438284090894E-002 -7.6376646781801519E-002 -2.5476725995322549E-002 0.51808401955203254 2.4294634186072341E-002 4.1911298578354177E-002 -4.2306161525803410E-002 -2.6980089030184257E-002
7.4703378773779305E-002 0.12409074485274416 -0.43379094568160831 0.56293979127859317 -9.9485022207704277E-005 -9.7727262875554298E-003 -3.6900272900630048E-002 1.6696371929482742E-002 8.8620757491216715E-003 -3.3201609737325707E-002 7.8955528822323012E-002 2.1984228476077505E-002
1.9558499994214596E-002 -2.5899261601346261E-002 -1.2560002362205575E-002 1.0849469788673792E-002 -3.8199337179595284E-003 1.1694874639968595E-002 -3.5853821845979308E-002 0.45001853807394221 -1.7180601802362409E-002 -0.17319365185049179 -8.3049592591085797E-002 4.7666732022626453E-002
-8.2112888431893571E-002 -2.4958819636050414E-003 0.19109201300530970 -6.7395676225291301E-002 -0.24923964156720785 -1.3266178880913183E-002 -3.5034064956896545E-002 -4.2070345539882162E-002 -6.5625497824373718E-003 -3.1565905479738823E-003 -3.8850829170957293E-002 -1.5947965712537149E-002
-0.10621243438660610 2.8001845414796667E-002 9.6625237489925811E-002 -0.20564557766417801 -2.6491882994706676E-002 7.2073195399028830E-002 -1.9451528955935219E-002 0.59380424094283579 4.7463932250150907E-002 5.4459826684636940E-002 -1.3234948862343349E-002 -3.8294122315798984E-002
2 113 124 : spinor index, minimum and maximum band indices
-6.4712688740900096E-002 -0.41385346280630819 -0.15854289514124489 -0.12818011145906419 0.33373298863368972 -9.5868502534157629E-002 -0.18224479566521593 0.15450412248027040 -0.17002405712189617 0.20972524107192472 5.8637598634006520E-002 0.11339571320957519
-0.33465974556203310 0.24914705626273828 9.1478105349923650E-002 0.14832516189392353 0.34717174202654927 0.74704862247348380 -3.1805960840376984E-002 1.6910066998288280E-002 3.5212371418691241E-003 7.5762844750820475E-003 1.0862419374998383E-002 -0.11102390581205621
4.8454428868245011E-002 1.5791153617428166E-002 1.6697415261525017E-002 2.5413969412920292E-003 -2.3942110032991962E-002 -4.7381790455207160E-003 -0.13198868812220141 0.10509210632497315 0.45664305353679457 -0.39119657476156544 -0.12956947090288198 9.4675861095643091E-002
-7.7016582530649191E-002 0.50271758798148825 -0.55179155267587099 -0.48970975795224525 9.8461200890664902E-004 -0.13562180225618004 -1.4668221119784433E-002 -9.7068385924447415E-005 -3.5999700316455593E-002 -2.1244339802900372E-002 1.3095880072688896E-002 0.11169304637246000
9.6916339539015114E-002 0.51240324173599705 0.19277518438885363 0.14107375897763011 -0.33148171127691861 5.9353561584422926E-002 -0.17532803520874138 0.12906053389405608 -0.14789220807648729 0.17595978411499194 5.6958980828243459E-002 8.5287211801406818E-002
5.7674625682689433E-003 -4.0880376028857746E-002 0.24433641127995243 -0.13918851382476674 0.11994666288308184 1.3208054096950705E-002 -0.58523823615812898 -0.11811326900138411 -0.13776608658837641 0.20301427246700879 -5.9818631854906344E-002 -2.3699280301003937E-002
-0.12205422360075063 5.2185487107683781E-003 0.10690279845162905 -0.22226081387969757 6.2458281889084623E-002 -0.14614832900990191 -2.9812019936447092E-002 3.0731413132606734E-002 1.0045434875670440E-002 -8.0212060190650979E-004 1.3197431494219560E-002 -4.0791831387209966E-003
-9.5810220657859945E-003 -1.4987731841315893E-002 2.6526688423124244E-002 -4.8713821760653607E-002 8.4290454271650928E-003 3.1885103576626220E-003 -0.44729695342919956 -0.10691678057776192 0.32480318951536774 -0.49842844354099197 9.3243457918172262E-002 5.6076901967732642E-002
-0.16111939367002392 0.26706214183093913 0.11155571863607579 -0.21914016957118551 1.0011653743613229E-002 -1.9264613461779462E-002 2.8658074707054639E-002 4.3410568666381238E-002 7.2018193810117004E-003 -1.3760932034161847E-002 -2.7511533473532971E-002 4.6112710752092625E-002
4.5232932344281482E-003 3.6338812361458181E-002 -0.28628996945335705 0.16551569460151036 -0.12397386992799111 -2.2693777726473668E-002 -0.50054498482856813 -0.10950377003844863 -0.12899565919354189 0.19639203972784272 -4.7338834297506856E-002 1.6261483563593537E-002
8 0.3750000000 0.1250000000 0.000000000 : k-point index, k-point (lattice coordinates)
1 113 122 : spinor index, minimum and maximum band indices
5.9583184937192328E-004 -0.19008171194015533 -0.23307489101445295 0.12506866550294557 6.1877202279488362E-002 -5.8850460101474510E-002 0.13822482150777302 -0.27530756601365181 6.3417045473950870E-002 -0.21482451255042881
0.44359679659527684 0.25052109658841759 0.15554875984468697 0.30489371599892856 -5.8073565405372889E-002 -1.7010166016647305E-002 -5.3267695077510759E-003 1.5966573426076082E-002 -6.9711937880639159E-003 4.4968303490726877E-002
1.9934746201868293E-002 -4.2066624436359064E-002 -3.7421262347151567E-003 -2.0409867218842446E-002 6.4940889872292385E-004 1.8938758905302097E-002 0.10332235112198603 -0.20666441369218622 -0.19241478239817358 0.58569102702599041
-2.4420217356041191E-002 -0.30802944784620223 -4.7284305548503304E-002 -0.10834675119834515 5.7919935668899934E-002 -6.1816736013188225E-002 -1.3969889538444396E-002 3.6057019618690081E-002 1.5107359148852070E-002 -1.4861915351212335E-002
1.3482802702986822E-002 0.13800068563434875 0.18725447601284101 -0.12613836595789710 -3.3411559653889263E-002 5.1280186056451522E-002 0.16683515725563405 -0.29602570144614559 5.1595609163586874E-002 -0.24656528452722395
-0.42576977333947569 -6.9607463003764594E-002 0.27718404131055235 -0.17387473595715675 -5.9294887121994905E-002 -0.40102064836026996 0.13656546609797252 0.45407047272144274 0.23527520517966635 6.1904681172694112E-002
0.42551518868148785 0.17380319472647243 0.49353674376220386 -0.39244364104078966 -1.2591911805124145E-002 -5.8822413274136717E-002 4.1297589890666883E-002 2.1813178438789858E-002 4.1695886106733832E-002 2.9829259955792865E-002
1.6770814524559662E-002 -4.2390072095409306E-002 2.5644194073878707E-002 3.5844601346004458E-002 1.5901851307905258E-002 -8.2408940966103399E-003 0.13531405561480572 0.42012071144790758 -0.59052534171310100 -0.12540859189339446
0.25776501395267359 6.8926933561774734E-002 -0.25029542859744597 -0.31502158915681155 0.74356142336666942 -0.30664923892851170 3.1129561064728042E-002 -1.2453154024994032E-002 -1.7179620720257385E-002 3.0844325642931502E-003
0.33692049184992517 5.7227391810782249E-002 -0.24429404602371257 0.13906370052089273 9.4570731513954093E-002 0.39195359426898146 0.14965615045010436 0.53770485875563856 0.27292033972642110 5.2366368051253831E-002
2 113 122 : spinor index, minimum and maximum band indices
6.2631977798842067E-002 -0.33718651935541921 -6.3700753895550799E-002 -8.0165923534728178E-002 -1.2938653465497085E-002 4.8301549340544508E-002 -0.18035440709626804 0.22356824188535723 8.3272448967326967E-002 -0.26414988378512338
-5.6708867522340695E-002 0.25660996845622741 0.22011105557196173 -0.13899872353173914 1.1291941098546240E-002 -6.3380069620020490E-002 1.6136491678682325E-002 -1.2644105013754063E-002 -4.9480223015809736E-003 -1.8959622262290962E-002
-4.4017883555104206E-002 -1.7544536049489020E-002 -5.2264557073517463E-003 -6.3010963524664752E-003 2.0025487115066968E-002 1.9375005791435209E-003 -0.15804254062627987 0.16908405500566973 -0.19881066398951011 0.56129226666888321
-0.18355282637713738 0.44270861964900610 -0.13255488056169731 0.33172330706848729 7.2509666741731316E-003 -5.5261568036356665E-002 2.6776750671673757E-002 -2.5961947604679514E-002 -2.3874251910943695E-002 4.2243473938112744E-002
-7.7058023959113722E-002 0.42541006964657313 4.9459291967749092E-002 0.11001552342757726 6.9387087457960465E-003 -7.0672884000228781E-002 -0.13468577747963473 0.19426194596649887 8.8700696411376651E-002 -0.22530763184938951
0.13562385522172618 -1.6496319716900743E-004 -0.17661777854414656 -0.29718339499420809 -0.39508476842824142 8.7902205434582104E-002 0.58671371590308019 1.5744974397694851E-002 -0.23791110639593230 -8.5852876367912542E-002
0.31051541526556392 -3.4576867571962183E-002 -0.25004886781823804 0.21344048572191004 -0.31261279224812988 -0.74311837036834538 3.4565042576861285E-002 3.1690859936695209E-002 1.4348539000322336E-002 1.2802048885141422E-002
-4.0359207777033460E-002 -1.9257693721153796E-002 -4.0915864265661066E-002 2.5139193348743361E-002 5.0619356632802997E-003 1.5795720767329283E-002 0.44071472522209459 -1.9903573053146245E-002 0.56501061507048378 0.26589039866491609
-0.24347630696614556 0.42644009542943573 -0.47895362184276952 -0.39715650711390854 -6.0806757754097968E-002 2.1841127097614543E-002 -3.7036595136463735E-003 3.2555465688922078E-002 -4.8393704088949413E-002 -1.6166328270329003E-003
-0.18717476402891484 -1.7411071659152025E-002 0.20840379697361155 0.34504179061772133 0.40525815012726379 -4.8478254295357286E-002 0.51364934684700292 4.2981863252073791E-003 -0.20521525685800460 -9.2797300383963374E-002
9 0.5000000000 0.1250000000 0.000000000 : k-point index, k-point (lattice coordinates)
1 113 122 : spinor index, minimum and maximum band indices
-9.0861109139377172E-002 -0.10309194664840468 -2.4327260560801306E-004 6.9581893875336380E-003 -0.14180946953666243 0.26726959168146380 -0.37358145458740477 0.17755394690123910 0.28674820963899694 -0.13741671244488926
0.57020565931525535 0.52479683696522317 -0.30179522929037805 -0.19214525927518830 0.10995854832772914 9.0776717017780145E-002 2.8074648619944902E-002 2.0640756907448099E-002 3.6472391349434023E-002 5.8270437295862454E-002
3.0455624401213965E-002 -4.1918187684321269E-002 -2.1841319505098615E-003 1.4018374110178602E-002 1.9338187653508837E-002 -2.5275644961714860E-002 -3.0896894784486536E-002 -1.5892637610299916E-002 0.14745553794710844 0.19590197769603185
-0.10939600587054102 -0.36153380268992596 5.8003891170243849E-002 0.15052664819188896 0.44607127830016624 0.25466563031170741 1.7239075300024116E-002 -2.5906179409704334E-002 -3.1539578542641160E-002 1.3037121866785278E-002
6.7244351175713285E-002 6.8790190785586208E-002 5.0263205753856340E-003 1.9098090725712866E-002 0.13464572260049054 -0.24618887758266950 -0.41933319041123762 0.18146417673193510 0.35680053923677202 -0.17887978746851660
-0.31532308539921378 -1.0589735869935174E-002 -0.49425783094431142 -1.4918627236685980E-002 -2.9157283515854868E-002 0.34180768932125272 -0.16236507799648095 -0.26443307408556332 -4.3131188563006101E-002 0.23967499763076464
0.10971598112476150 9.4625959276659372E-002 -0.21751375578066301 0.41181445829835983 -4.2525370014926539E-002 6.1919134019782981E-002 -1.1133105059221172E-002 -2.8009743536283764E-002 -1.8840180676103973E-002 1.9532919689678824E-002
3.4211504555000376E-002 -3.7242558985535482E-002 -3.0355340923343299E-002 -2.3614290497972246E-002 -9.6127833071984678E-003 7.8523537302978685E-003 0.26791868413233039 -0.56626625858077317 0.58831556323184009 -0.43821183319715512
0.16818374336493602 0.12630591772692445 0.10447020100183184 0.45090719418576808 -0.52933230077778659 0.16037830215579674 -9.3026986666825701E-003 -1.2935890581815259E-002 -1.0581004207583442E-003 2.6396174173113136E-002
0.24159129439184185 1.6213552144436285E-002 0.40960694891555405 2.0863675197688836E-002 -7.4826696913572847E-003 -0.33924556480322399 -0.18535065849035318 -0.30406388080578800 -5.6688095105177791E-002 0.26745901797459792
2 113 122 : spinor index, minimum and maximum band indices
4.8626005798620586E-002 -0.24261415761905578 1.2796673417351761E-002 0.10507813667417504 -0.28981277698319047 -0.13239718201634162 0.20488518790151422 -0.33894738731582208 -0.26223243701456195 -4.6489587832154650E-002
7.2765150704408865E-002 9.0304412637235959E-002 -2.4011735988788141E-002 2.7841702115461178E-002 -0.27401885938836296 0.37037445862153817 -2.2291980336332173E-002 1.5417687744384697E-003 2.6762277497673816E-002 1.9557043294950709E-003
-5.3276218551465311E-002 -4.4890404639145162E-002 1.9840180890195552E-002 -6.0422105956580343E-003 -2.3981833478271770E-002 -1.7860651040978434E-002 0.52439698976118898 0.23255573860847231 0.43241338455114703 0.59235798019621755
-0.34583536217272376 0.38172967870619567 0.29560891451140919 -0.23236657527403698 -9.8320701967592850E-002 0.10319278824533848 -1.7287430468556214E-002 -1.1685326131702011E-003 2.1200650498802289E-002 1.7789662961741108E-002
-6.1025732218858292E-002 0.31821582768199430 1.0708532444587021E-002 -0.13240088941100950 0.31104574855095252 0.14445141171469386 0.17020264569305232 -0.29943606806634659 -0.23564523366911244 -3.4943190069137320E-002
5.1284208922472638E-002 6.3454176218206912E-002 -2.5220203832633202E-002 0.39592938989633231 0.30283175117676520 -2.5624401714273881E-002 -0.28884131543789715 -0.30881486944598807 0.18640193606048042 0.35818977167112476
0.37598395699180187 -0.17916657209205430 0.47475861189568613 -0.11619820652331296 0.12445487613523731 0.58480679424518089 -1.8476106850369423E-002 -1.9527309552186900E-002 1.2278042417389810E-002 3.1494690411354810E-002
-1.7484927126121312E-002 -9.1058002748902710E-003 1.8987524242913185E-002 -2.9828151594785964E-002 -1.1200186784206910E-002 -1.2139001936825015E-002 -0.21432133174839940 -0.13641731035719115 -0.20834084956874979 0.13045160606653161
-0.40591312133852298 0.43755155496501963 0.34514763459812980 0.29051540650119295 4.9073444819583388E-002 5.7007159356722015E-002 3.0202999992463949E-002 -3.0176859310145090E-002 5.7683296849180540E-002 -3.6992784738556016E-002
-8.3756192306405616E-002 -8.0145127183773299E-002 1.2499939977687996E-002 -0.47619322381582263 -0.30251858393705544 -9.7106525758944712E-003 -0.26925262609804534 -0.27623371114088618 0.14416782041862966 0.28778609910246378
10 0.6250000000 0.1250000000 0.000000000 : k-point index, k-point (lattice coordinates)
1 113 122 : spinor index, minimum and maximum band indices
-0.20473482902077517 2.0351429229153090E-002 0.19444730817825726 -9.9562469462563433E-002 -0.18413284812650563 -0.37194743457711743 0.25160858105232453 0.19697693242841513 -0.20499950356851751 0.15853049026360330
0.47856013309637291 -0.44161690305644524 -0.17146478571711429 0.41269900558442296 0.18271761095047048 -8.4414439753295267E-002 3.2282839835130972E-002 -1.8442587315163468E-002 -2.3367403297764228E-002 2.0990073584166755E-002
4.7023939968853339E-002 1.6088344384743398E-002 1.7346966364276416E-002 -1.3536186292649712E-002 2.5369836739255185E-002 3.0848035014049064E-003 -0.63642392411197557 -0.52954704178481671 -0.20162940112438685 0.10622831121075813
-0.14099023481858564 0.39247392042029366 -4.6512164183430856E-002 0.31173498643941833 0.57233482785900258 -0.17479330270123739 -4.7459865940071965E-003 8.4305293632814179E-003 -9.8075485219546767E-003 1.1143091013868419E-002
0.14315791761117885 -2.3023031880963687E-003 -0.16474261130990528 7.5219067549820565E-002 0.17795662968950757 0.36607950276107259 0.29071518587680623 0.21917989314746611 -0.23285098810606794 0.19229343540460261
-0.12950509786660769 -1.1499893467928318E-002 -0.48059660200276250 -1.4501018880864976E-002 -0.11593157191431237 0.21213271860118396 -5.6661190823032222E-003 6.8714233946111231E-002 -1.5058688349873202E-002 0.50687828413247549
-0.30131399304860074 -0.37763866085709691 -0.20825461306861459 -0.18981989892747714 -1.6884146349205945E-002 0.12358724094139562 2.2659990289089490E-002 -5.9433326564368227E-002 -3.0751145148319652E-002 8.0076718151469821E-004
9.8560062652547371E-003 4.9020603505153040E-002 -3.0954192237177179E-002 -4.3687396060512382E-004 4.7755348514943547E-003 -3.0194608797407572E-002 -9.6504479584001074E-002 -0.21948011851331703 -5.7399109329473045E-003 0.44394555189777940
0.22904432072377948 0.14273519015515551 2.7228188161641201E-002 -0.38419768876934596 -0.24712158410152862 0.28965539480554336 -2.2537427378197607E-002 1.4081443525898150E-003 -3.2037953040800662E-002 -2.4910725923576772E-002
0.10526840321863885 4.6588394311596086E-003 0.40001991626895700 -5.0804250958797750E-003 8.8643469345303025E-002 -0.18713115964599167 2.4111294570207061E-002 0.10502826027339537 -1.3914047396820036E-002 0.57570975567223126
2 113 122 : spinor index, minimum and maximum band indices
-2.1194037372707034E-003 0.17236874030224231 -2.9798690850851264E-002 0.28079921914812822 -0.38780562030104104 5.8295336784308184E-002 -0.16436983421481827 0.10782173320117197 -0.22799493794381037 0.16793292622096412
0.36017765318468370 -8.6584730719185002E-002 -0.19966539804163327 -3.0104121030438691E-003 -0.33038930157579161 -0.57335690699265329 3.8024078831721819E-003 2.2942019218250606E-002 -2.4657425467621653E-002 1.3367383299697678E-002
-4.8023152530079362E-002 3.7572965249267461E-002 6.5631832744133664E-003 -1.9630767010615245E-002 -2.4015686434681549E-002 1.4009480643983867E-002 0.36433124933853567 -0.27785970889011780 -0.20777831500808247 0.14951124486875531
-0.57248451267744893 -7.2950441317717205E-002 1.9367127554644509E-002 0.26354843121425975 -0.14774363519329578 -0.13808446602578325 -6.2228726042840646E-002 -3.1086745686272621E-002 -1.5432343410198765E-002 2.2247812807239167E-003
-4.1164321354835850E-003 -0.23029865127894461 5.8329963930115719E-002 -0.33895119834558474 0.40997295835765735 -4.2764072197494889E-002 -0.12315933012286534 6.7934881606070585E-002 -0.20892277770254253 0.14602135830766672
4.7403456079703216E-003 4.3179568614864362E-002 -6.9251882714568003E-002 -0.32909784562553862 0.13653251684294404 -0.19007403813652790 -0.17903732692007154 0.27106054607156993 -0.56252392286104613 -0.16190089803720711
0.21137458879007703 0.25464477247691819 0.45267777040053253 5.3808993955189122E-002 -7.2771676941596392E-002 0.24474954713380881 7.6533236811900506E-003 -2.0314766696415305E-003 -1.1690919710569396E-002 3.0723433558559513E-002
1.8856604500103884E-002 2.9946771629933103E-002 1.1846398863886130E-002 2.9558198939472168E-002 -1.8561331713789247E-002 -2.1683645469502338E-002 0.44255318209315087 -0.58063548215714489 -0.40645651595111626 -0.13539933928912726
-9.9488237254755529E-002 -0.56078923806080283 0.45384818762591433 5.7577759477997245E-002 -2.3917273214914408E-002 0.12084075420482820 -3.1249480166246598E-004 -2.4274696830151776E-002 1.4249292504493631E-002 3.8557281609602381E-002
-2.3006557391135704E-002 -7.5169571573817151E-002 8.1980610956630645E-002 0.39229231149142102 -0.12356711601534787 0.21334662021478801 -0.16838514415468439 0.24233529045322208 -0.48826777612278849 -0.14467042471291355
11 0.7500000000 0.1250000000 0.000000000 : k-point index, k-point (lattice coordinates)
1 113 126 : spinor index, minimum and maximum band indices
0.17232047633035402 -5.7329200249788714E-002 0.23123503286662350 9.8693183928826367E-002 -4.1181385173205021E-002 0.11298048626961558 8.3865065952216239E-002 -0.20326192045369207 0.10851140251340427 -0.40403337594047500 2.3043532526855509E-002 -1.0280144310711632E-002 0.10225753652576934 -9.1412072860312180E-003
-0.18203896341976544 -0.57473819580791241 -0.13625685047228514 -2.0076946032152557E-002 -8.8426419091593780E-002 0.11368658625202896 -1.0803278531911056E-002 3.8590329229564360E-002 -9.8070160804171816E-003 1.0904942529050863E-002 1.7721558676604084E-002 -4.1798036398236968E-002 -3.5852719645899110E-002 -1.1073538421560350E-003
-4.2620618672839956E-002 4.3113453346490360E-002 1.4308257500887578E-002 9.8265455249960630E-003 1.0793458438751241E-004 -1.7694576497442070E-002 -0.16666156994332981 0.54869710888380174 0.10472411268659174 -0.35357411919579423 -8.1716248249781038E-003 1.8674942254154666E-002 8.9517591974575317E-002 -2.5756381938866736E-002
4.5723935967808049E-002 0.38632321105478123 -7.3860577679182457E-002 9.7931708537638079E-002 -0.33806402707477573 0.26082393233147438 1.8467741673425686E-002 -8.4882507393446403E-003 -1.7040809010567124E-002 2.5698448885059694E-002 3.4595209398862035E-002 -2.6106887089136180E-002 -9.3645932666801702E-003 2.0205413482006088E-003
-0.12455541282567645 3.6953459899607063E-002 -0.19290668386887627 -7.7119232597010229E-002 3.1649829223767550E-002 -9.7462475026070153E-002 7.0903943838268008E-002 -0.23851217502972694 0.12874575714112887 -0.44650801412615898 -3.3784136590853935E-002 5.2569799405365283E-002 8.0982195452856801E-002 -1.1843211534172168E-002
-3.8234069660885557E-002 -3.6879428033169591E-002 -0.47389794587486078 -7.5436856258468590E-002 0.24887549652932411 0.40294879855925686 0.22711076967687921 1.2448888573225863E-002 0.25881363033696131 0.23478582635864048 -3.8192861042941742E-002 5.8548051700686957E-002 0.13665924489854625 1.0440439033415968E-003
0.54249396753110213 5.9262736944085265E-002 -0.15341964748318704 0.46159844550798446 -0.19682709138410220 0.11352576451672572 3.7522234690374044E-002 4.9915158003845883E-002 2.7396896692546538E-002 2.1528252618303930E-002 1.1383294476820467E-002 5.6962689901811428E-003 -3.3724540650416166E-003 1.7825799621370458E-002
2.5306139393825065E-002 2.4097020207244187E-002 -3.4971012854630584E-002 -7.7017799951096186E-003 -2.3003760910406588E-002 -2.0257987754313249E-002 -0.61524525993803569 -2.5658509580868635E-003 0.23702400790410535 0.17968342798955450 0.14685863578408287 -0.11765172228878916 0.12526801591795961 1.5728320880016140E-002
-0.33311812615090919 -0.13129123255602101 -3.9266581274328298E-002 0.47904481846291724 -0.47708109532583182 0.24364974176020845 -1.2296699603383471E-002 1.7797661771831556E-003 1.5954411542127810E-002 1.1323565473723912E-002 1.9428655978729103E-003 -4.8139112028967174E-003 2.9171057305867054E-002 1.8700253430590889E-002
1.8609782781991893E-002 1.7425530905920646E-002 0.38786417406533036 6.4018717032097563E-002 -0.23404441519642238 -0.38460521214198423 0.27570406865208347 -9.9772146901598805E-003 0.28810272247681962 0.27891277231282391 -5.3824894604681414E-002 6.8629861946477314E-002 0.19644618714233342 -2.1721993952055225E-003
2 113 126 : spinor index, minimum and maximum band indices
1.8167287264279915E-002 0.10922493539609915 -5.7622418301600420E-002 8.4385624330608436E-002 0.21409288133941637 -0.19245907160465833 0.11039325557382321 -0.20352637246601565 -0.35037138838664333 0.26219704294925328 8.5032546362130451E-002 6.3310052536840050E-002 -8.3232397016673940E-003 4.9647375795010829E-002
-0.38442708571910644 0.24254384784450930 -0.22019321022499488 -8.1570532146378383E-002 -4.6643507073952303E-004 0.11711045586064628 -5.7794811889426388E-003 -1.9872642219156852E-002 6.8169998568906381E-003 -1.8604611714656539E-002 1.6181710188667663E-002 1.7492627556853119E-002 9.3307097169649730E-003 -2.4696331798219770E-002
1.8859737750308476E-002 4.9127814777575357E-002 7.4602964560626416E-003 -4.6306821544436372E-003 2.6874211252106853E-003 -1.6864831870380390E-002 -0.27607577164997754 0.44995845806950086 -0.23686832423149154 0.21591389517430654 -9.6232862884557152E-002 -0.12699529377997013 -3.0079448539661914E-002 9.8701748763590428E-004
0.48750248202233137 -0.47935713668063507 -0.10174318128022238 -0.17174595178350066 5.1442600371239093E-003 8.3207862885941286E-002 -2.3995717948129065E-002 3.7905889368670259E-002 1.9373832783040692E-002 -2.8659818936647503E-002 1.3974265375918199E-002 1.8210237387493378E-002 1.1352355327971374E-002 -2.7058923495856271E-002
-2.2077332825360042E-002 -0.15886131402867296 7.5445435904059388E-002 -9.8796383275396873E-002 -0.21687281097001540 0.20980027847714258 0.11223164413107675 -0.15494786919186462 -0.29970069572878305 0.23674882827990654 4.7419890380885961E-002 2.3500863147061422E-002 -8.0171299344539565E-003 -2.6491257286266161E-003
-3.6588749516386826E-002 -6.2690465919773605E-002 -8.2008806614690524E-002 0.42488648176311239 0.33404613935740363 -0.13688750164955596 -0.21166445392525302 -0.19904594570151410 0.39294005979294705 0.17559179199284797 1.5529651018691734E-002 5.5470818133689336E-003 8.7072289941102204E-003 0.20659471524561149
0.13673932996182148 0.23287727988269960 0.43656107098509567 1.8509725914768876E-002 0.35692281212498250 0.57287358368428409 6.4642189058748308E-003 9.8665202946483493E-003 2.7240796746896528E-002 1.4099758114705064E-002 2.1043965537013716E-002 2.9912692089858396E-002 1.6329365158061833E-002 -1.8131160295806113E-002
-4.5647740780142283E-002 -6.5984582821282884E-003 1.0010246584484522E-002 -3.7499433886236201E-002 2.6762934419807642E-002 -1.5645201986448556E-002 0.47419206299361344 0.45148083494877900 0.31811802297775077 0.14328106289369955 7.0240671826138579E-002 7.4190744489396651E-002 2.3654007858252856E-003 0.15395434744336597
-0.31012431188397166 -0.31249145462403533 0.45069546560981055 0.11229274829907152 0.16058210018270086 0.19908697664437627 -5.8352680479966140E-002 9.3666389900463210E-003 1.4386264534294023E-002 5.0352678225980500E-003 3.9801261465203151E-002 1.0590542787492531E-002 1.3785716576023149E-002 2.3762313999787937E-002
6.4486928306129204E-002 7.6936957272603065E-002 9.8687767600622464E-002 -0.51796423056362462 -0.35791136120619632 0.14006798953359081 -0.16992453563373300 -0.18602696635209146 0.35853320243318748 0.15069938171331532 -3.5823846645319665E-002 -3.7913207588033335E-002 4.5216813723583226E-003 0.17065706339149486
12 0.8750000000 0.1250000000 0.000000000 : k-point index, k-point (lattice coordinates)
1 113 126 : spinor index, minimum and maximum band indices
-9.1455825995053128E-002 9.2804981624330457E-002 0.49763683879993892 -0.12023251554499183 8.4579876540933768E-002 -0.21859004235670870 -0.16553031253740366 0.14566551545135931 -0.31205220126925493 0.35253575515563529 -6.1040576175306484E-002 5.7401443919379180E-002 -0.15105473718601831 2.0110572489710467E-002
-1.4751056400510835E-002 1.4844119071948832E-002 1.7513869467327615E-002 -4.2912357720158254E-003 1.5624777262936086E-003 -4.0039428531039121E-003 1.4683950574087734E-003 -1.2943286800727516E-003 7.7894917473413886E-004 -8.7918842300063109E-004 6.2822484600391648E-004 -5.8813106840458190E-004 4.4122394571650150E-004 -5.7641267325428137E-005
3.3283008310230004E-002 -3.3772132079119957E-002 3.5858091040674576E-002 -8.6637769304355079E-003 -4.5620684262856551E-003 1.1794452658773281E-002 0.43847783995877915 -0.38584514072433684 -0.27214441632701625 0.30744748616230583 0.16273202121335298 -0.15296857636448546 -0.13345443998790804 1.7758464869358354E-002
8.7683428132609639E-003 -8.8232480532798828E-003 1.7474829678466586E-002 -4.2797479879352375E-003 4.8666366356139683E-003 -1.2457009643809006E-002 -3.8651702034097496E-004 3.4172572079680893E-004 7.8366659465573852E-004 -8.8596793614181075E-004 -1.8429321145535838E-004 1.7276712654278335E-004 4.4645627487949771E-004 -5.8424981518503038E-005
6.4409584900535791E-002 -6.5360029142862791E-002 -0.41068706143760947 9.9224938043440278E-002 -8.1036478569613712E-002 0.20943065362499297 -0.19366868352604752 0.17042553797332388 -0.35268032282572981 0.39843388031308369 -7.2583157531559472E-002 6.8254295249619762E-002 -0.17413091620296101 2.3182808722018652E-002
0.11024526316720989 -0.10101618482515176 -0.17928410468628117 6.4968355405446682E-002 -0.16812324169495599 0.38327726132810136 -0.17088502611727363 0.13461389750249575 -0.12543107913979451 0.11269963205505944 -3.5731627238432394E-002 3.8759089384136372E-002 -0.22665746133878992 4.0885240539800471E-002
-0.57511245347852236 -0.60046931389827773 -0.12347568015720393 -0.48266006590104060 0.21035473626602852 8.9619600942256433E-002 -4.5887205230914344E-002 -5.5062078601202782E-002 -2.4527255884478752E-002 -2.2269366176315846E-002 1.8578596601817793E-002 1.8971417780500054E-002 3.5161584396653125E-003 2.1315988959143804E-002
-4.0105977713565950E-002 3.6774240911492020E-002 -1.2922350864822676E-002 4.6607892525760098E-003 9.0473509736868473E-003 -2.0685816662674023E-002 0.45280768372853225 -0.35641323612278514 -0.10934040054667753 9.8332354551711618E-002 9.5157939321331514E-002 -0.10340084559888486 -0.20025866363800587 3.6043832587086898E-002
0.34168115844162322 0.35676294685343696 -0.12338431283223385 -0.48229263982949078 0.65410837045777681 0.27868408728177652 1.1935809999077038E-002 1.4334999835156667E-002 -2.4482661834875026E-002 -2.2233878391690189E-002 -5.3607585722519734E-003 -5.4724021687387334E-003 3.5081531573881880E-003 2.1209001936234793E-002
-7.7629275824667693E-002 7.1157884471099553E-002 0.14796408064470082 -5.3600673020024171E-002 0.16102780652585089 -0.36723732098612638 -0.19995032457344175 0.15747527773619879 -0.14179240452819108 0.12734254933865652 -4.2476979233453262E-002 4.6097686217929340E-002 -0.26128061454897272 4.7164917581593913E-002
2 113 126 : spinor index, minimum and maximum band indices
2.4753143420862432E-003 -2.4891679914100582E-003 1.5801754900607656E-002 -3.8773489307071464E-003 -3.1455858943512886E-003 8.0380408893911213E-003 -7.4130064355724910E-003 6.5331292965930344E-003 1.3596944605628176E-002 -1.5353835987554113E-002 -2.7797183410617631E-003 2.5996888574092315E-003 6.7253641070671886E-003 -8.8012981400379417E-004
0.22787243729358075 -0.23122468882157721 -0.45375565053953121 0.10962688647958942 0.12539082744820185 -0.32406104291065885 -9.9696750067555812E-003 8.7742833307435167E-003 -2.0649511142785831E-002 2.3328786195515133E-002 -4.7276036416974958E-003 4.4458316113698687E-003 -1.1761000439711372E-002 1.5662041137312177E-003
1.2752548818881068E-003 -1.2837639112487764E-003 -1.3626924343886841E-003 3.3396047731767031E-004 -1.7259444921476224E-004 4.4168556554622100E-004 1.6872496575236002E-002 -1.4865798697706274E-002 1.0432002049382895E-002 -1.1776093075731192E-002 6.2841933713586344E-003 -5.8775681420940654E-003 5.0891892253717846E-003 -6.6471835555810912E-004
-0.38354750160913764 0.38917005907086233 -0.45411606213408567 0.10972243372831535 4.0325412259308163E-002 -0.10421221223696708 3.8320042666152250E-002 -3.3718786927007298E-002 -2.0684972536404275E-002 2.3368921875067904E-002 1.6383255715467358E-002 -1.5400446993158550E-002 -1.1820843547957118E-002 1.5729285643909881E-003
-3.5269192426855755E-003 3.5490591856009251E-003 -1.9166215479756877E-002 4.7007490085249183E-003 3.2933796132075237E-003 -8.4149362777427520E-003 -6.3224632269845982E-003 5.5716460169992340E-003 1.2008347352105864E-002 -1.3557342563287842E-002 -2.3298916910898626E-003 2.1801350684749954E-003 5.8178685424670534E-003 -7.6043444825718239E-004
9.6578057514927415E-002 0.10083778829296665 -0.11166485317269176 -0.43650989524135825 -0.42275045880734019 -0.18008900182591134 0.23192539076682106 0.27829459773813142 -0.41807013832352324 -0.37980949400091135 -8.2283022018471999E-002 -8.4054149071945347E-002 5.2118719871528274E-002 0.31398577172735825
-0.27464934091229481 0.25171531567076361 0.16347274468745518 -5.9232790638277605E-002 -0.24919151049110153 0.56821931406580684 -1.0300946733424264E-002 8.1005037947120447E-003 -8.2864145369840082E-003 7.4678568441860407E-003 -2.7625182665348799E-003 3.0067448290762729E-003 -1.7649697527915068E-002 3.1714508840751882E-003
4.9912506654350056E-002 5.2103930624703448E-002 9.7416581507705994E-003 3.8112918693145627E-002 -2.3810265472044585E-002 -1.0122929307136604E-002 -0.52500003381161797 -0.63013323831480061 -0.32262797055980563 -0.29305384749802144 0.18456523658942225 0.18841238527510887 3.9862753997710262E-002 0.24063063189331282
0.46224886050207087 -0.42368749267650013 0.16359711082687708 -5.9304628369128351E-002 -8.0135990611170743E-002 0.18273052620297692 3.9562517954631789E-002 -3.1156616526179116E-002 -8.2943436256574694E-003 7.4882853697591113E-003 9.5845929265271235E-003 -1.0405793918268597E-002 -1.7740427712736161E-002 3.1748778921891077E-003
-0.13711893033047248 -0.14319647114600781 0.13531409720905946 0.52892696276717088 0.44122021591341820 0.18801078105970584 0.19824065988276052 0.23785239211337567 -0.36991772181866545 -0.33604758684503466 -6.9192885527808515E-002 -7.0692966494089030E-002 4.5187163527887278E-002 0.27237689751431143
13 0.2500000000 0.2500000000 0.000000000 : k-point index, k-point (lattice coordinates)
1 113 122 : spinor index, minimum and maximum band indices
0.41073494452380499 -7.9286424389085706E-003 0.17189212964334130 0.12537850338596479 3.6274320217115123E-002 0.41485358277353135 5.4436744678908730E-002 -0.21618113699126568 0.24408380032440671 0.22464507143943435
-0.56495110061553522 -4.9677050469320916E-002 0.28608504629016429 0.17925910409155096 1.1991071310448687E-002 6.7056449374038110E-002 5.0780046766219278E-002 6.8991279466810232E-003 3.5364008198974457E-002 -3.5952802494441584E-002
3.0125411931952411E-003 -5.2386860619477608E-002 -2.5682419766875846E-002 -4.1618862037443694E-002 -1.6006959933803650E-002 4.5493619674548454E-003 6.4472210258636850E-002 -0.18826054990549468 -0.61983961828899148 -0.60143139190994443
-0.16648822570766730 -0.35011730771003285 0.14352600643081120 0.28424168608388989 -0.74685388435245326 0.30133286198603448 4.6878476159389046E-002 2.1590603794761052E-002 -1.1387276242415848E-002 1.2889526012037000E-002
-0.32464312472527457 -1.5949435910712011E-002 -0.13968315520288979 -9.9771172750944742E-002 -7.5124751031579812E-002 -0.40256365947314343 5.9793488565723946E-002 -0.25680873161303280 0.27498374297286554 0.25271868837541489
-0.22262660355605010 0.16764255518778262 0.26982262515154976 -0.20127060738474695 7.5940406920136832E-003 -2.3685656495592120E-003 -0.13333970393826600 0.49392298276679519 3.4301595293445460E-003 -3.5812972812215666E-003
0.28184950636706224 -0.21222014668162781 0.52462590721618052 -0.39136907463318277 7.1902651467792983E-004 -2.2625133683605754E-004 -3.9321941123495905E-003 1.4568521395164355E-002 2.6490134740224752E-002 -2.7668843574674529E-002
-2.2684633434165796E-002 1.7083333239426284E-002 1.8475200630846459E-002 -1.3787875133511724E-002 1.4395342650035162E-003 -4.4582416310591240E-004 -0.11877740257321968 0.43998957019227836 3.0372890998434658E-003 -3.1739755875937184E-003
-5.1898814089668385E-002 3.9089304754069396E-002 -0.23597621333769037 0.17607845225612390 6.9438672951546682E-002 -2.1463956301897784E-002 5.1607288488636606E-003 -1.9115141306176545E-002 -9.0275054419258448E-003 9.4295698636329816E-003
0.16702683315033004 -0.12577395595172494 -0.22469128080263895 0.16760698405478353 -4.0687214216613430E-003 1.2785897987886447E-003 -0.15763962393998265 0.58393453118266136 4.0018753234562447E-003 -4.1795833159574232E-003
2 113 122 : spinor index, minimum and maximum band indices
-6.8503340378331307E-002 -0.35613741891195277 0.14648142735958425 0.24648683310856531 0.40103899181778718 -7.4449835730191705E-002 0.63790832462619618 0.16840077818670454 -0.19871115315845828 0.22138932988732013
-0.29355426694146314 9.4345914670305231E-002 -0.22519580406960860 -0.20565965831963998 0.30203858391527044 0.75007520725897159 2.6147245269995428E-002 -1.3992281897372989E-002 1.5966730173276728E-002 1.4528018371523869E-002
5.1133454237147602E-002 1.6872629315265345E-002 -2.1185119691531095E-002 -1.3455232215919178E-002 -4.5711372062590258E-003 -1.6070588300954786E-002 0.47856109800750868 0.13464418592856353 0.48083997396968992 -0.49174153899074269
9.8167918815114399E-002 0.61411379054653703 0.35186159595914268 0.56818367080123111 6.6807272658167771E-002 -1.1879046009024952E-002 -1.0599823883703327E-002 -2.3887704026543992E-002 -4.5366182574934383E-002 -4.4184070473487172E-002
0.11368759912709181 0.45784034146015012 -0.17488396328602945 -0.29675865764913006 -0.41337619036530332 3.5439229149157495E-002 0.53916045333734919 0.14398440952973593 -0.17671724844877745 0.19643731556003219
-0.10666982067839140 8.0338700677301825E-002 -0.12881636782671532 9.6128445666273349E-002 -3.5058351927741281E-002 1.0832639873324664E-002 -2.1900712393854490E-003 8.1499144648357544E-003 -0.15619887966579377 0.16314954227896739
0.19478475895307737 -0.14668096316926671 -0.24714106136883032 0.18434134686747705 -5.8148627286307656E-003 1.7583173562928014E-003 -1.2157747855538789E-002 4.5037629119321562E-002 2.8822936405983548E-004 -3.0057097902338943E-004
-2.0530810912919382E-002 1.5458435481261398E-002 -3.8385112937637411E-002 2.8635688156310669E-002 -3.2043262782960652E-005 1.1435693518386875E-005 3.1558681882667247E-003 -1.1661818990165825E-002 0.36127955553422081 -0.37736230269840348
0.19461774940499507 -0.14656908268646091 -0.24795369922752444 0.18504746482384332 -5.8250921326742488E-003 1.8008932492386241E-003 -1.2143411107386627E-002 4.4982815348402649E-002 2.8536975823365728E-004 -2.9786733592803148E-004
0.12344358675202621 -9.2972199060127950E-002 0.16016342117397162 -0.11952057427251786 3.5082545270644090E-002 -1.0838138556253641E-002 -8.9640952088271579E-004 3.3547330322856858E-003 -0.13874074312506807 0.14491514026876073
14 0.3750000000 0.2500000000 0.000000000 : k-point index, k-point (lattice coordinates)
1 113 122 : spinor index, minimum and maximum band indices
0.25219084249907803 5.6443728201877853E-002 -9.3143088162331356E-002 6.2755850179589429E-002 0.10397979617040057 0.45162356837561735 -0.18235289435007329 0.13373722299030769 0.23636210809039704 0.15609287152465465
-0.36098464310152234 0.19132822103679784 0.10234551088133992 -0.26835411640124174 -0.12016470510402077 0.10657349795998601 -2.0760878867529590E-002 2.3460657653966422E-002 3.8666020682244659E-002 -5.4337096123318024E-002
-4.1428971860629889E-002 -4.4161842024089785E-002 -7.7768237445501702E-003 1.6811556124585039E-002 -1.7969902268381893E-002 -1.4368457450609070E-002 -0.15813944400965135 0.13462494851973045 -0.62468603025318725 -0.42135613037936470
3.7320330908933108E-002 -9.0297109118652158E-002 2.0977436324203534E-002 -0.18264162756310529 -0.47269216061449759 0.21036872254507610 -1.1296892172462551E-002 1.5989725487046007E-002 -1.1095976333477673E-002 1.1320541445343765E-002
-0.18324218155423252 -4.5179084898748133E-002 6.7936499110298088E-002 -4.3351426778693955E-002 -0.11201660710490738 -0.43323951475455147 -0.21588096321709488 0.17274734957590668 0.27443606959393430 0.18673922110501526
-3.5949610703588278E-002 3.2024404288460248E-002 0.52630335799517192 -4.2547556676585489E-002 7.4459281575001812E-002 -6.2446683045605279E-002 -7.5086910779957492E-003 0.50731173196530255 -2.1989477521903084E-002 -0.16118842727523708
0.46644166592854552 -0.55110415107583532 0.19260092346139032 0.37684295131665785 0.11003093080358353 -6.4481781134670874E-002 -4.5704288832696033E-002 6.4767540737516865E-004 2.4990695594934800E-002 -8.4806011014182153E-004
8.6159667486709647E-003 3.4952486666508700E-002 4.5963793578636648E-002 -7.9904125946202477E-003 8.8910322942683095E-003 8.1768355396521653E-003 -9.0283534204147788E-003 0.45138745177227002 6.3611840713797288E-002 0.41600283734365601
-0.22198070026034999 0.37775883096194418 -0.14196700683402078 0.46124751223869526 0.47449728862776397 -0.18794608252445480 -4.5000360520448951E-002 -2.7847449128966185E-002 -1.2685322371875678E-002 -3.7777211298883166E-003
2.2727477631134828E-002 -8.7209897736104606E-003 -0.41067801105590246 5.1141881637177360E-002 -4.3286140298343323E-002 5.2510309843837456E-002 -1.2041376377209733E-003 0.60147651915358857 -1.6373305471072228E-002 -0.18019502430402401
2 113 122 : spinor index, minimum and maximum band indices
-3.5865721427102790E-003 -4.3178941445786947E-002 9.4127073711462242E-003 -0.16147658028505546 0.32910333945283959 -4.2857728263599085E-002 -0.20075745072229867 0.17672124124488836 -0.21019314831266664 0.27401357031535883
-0.38551393264922573 -0.22477256729143358 9.1402944894640972E-002 5.7946474512643120E-002 0.28045507419184246 0.66893753024936142 -2.9006860087352752E-002 1.6358003285222762E-002 1.1737603388710684E-002 9.2042969315126854E-003
3.9694998715644483E-002 -1.3219632490664702E-002 -9.9617095191078756E-003 1.7926262699269203E-002 1.5694883872501883E-002 -1.8635763794136027E-002 -0.14656459701614530 0.12481395816485820 0.47560123308192459 -0.62743023326188396
0.56912015077857459 0.50406073619888692 -2.6116014307364890E-002 -0.18927968307259077 0.11925614314388017 0.16218368856881177 -1.8910107240027695E-002 8.9815186889794715E-003 -5.3679363045791198E-002 -3.4773417529344292E-002
2.5475184960860958E-002 6.4068304077895447E-002 -3.0411950677783829E-002 0.20179992026386756 -0.34879283278185863 1.4323018146078908E-002 -0.17915960772356643 0.14557645265899849 -0.17718049407022460 0.23710648202952506
-4.5868361362514570E-002 0.17952631092356533 6.6379273158180069E-002 0.38366050513336269 -0.28661252508397544 0.11218205612006468 -0.59271738496008730 -0.12399732084389339 -0.15218568662941165 -2.2330036283284768E-002
4.7261105815771434E-002 1.2124089511840103E-002 -0.48759528330075214 -0.13128796695198830 -3.0387842283885372E-002 -3.3341555500195096E-002 -1.3773352222556949E-002 4.3417015889543831E-002 2.1503816480179169E-003 -1.4117793246868224E-002
-3.9952844627782112E-002 4.0198546854737324E-002 -1.5723525533017167E-002 -4.3032431785306587E-002 -5.1947987148933186E-003 7.3936081233892566E-003 -0.44765019263296257 -9.7526302337635512E-002 0.35270849657912245 2.4743241858573021E-002
-0.12815938275515454 -0.30626377470869393 -0.46189191591333761 0.10836993040700037 -3.5975916977070463E-002 -1.5566944215510350E-002 1.3899590525042154E-002 4.9388582988963231E-002 8.4708963536341587E-003 3.0172562052901697E-002
5.9680281225734710E-002 -0.24655189206836567 -6.9453551353933496E-002 -0.49492093862390807 0.29361279443242144 -0.12708744019063764 -0.49310595019324355 -0.11007440852915854 -0.13767144272225643 -1.1420636498275726E-002
15 0.5000000000 0.2500000000 0.000000000 : k-point index, k-point (lattice coordinates)
1 113 122 : spinor index, minimum and maximum band indices
7.9340668894602132E-002 -5.7792606516320441E-002 -0.22067657807341015 -8.0093582785726869E-002 1.1779268945903074E-003 -0.30021164534355460 5.8361968005614294E-002 -8.6569849847138738E-002 -0.17555302407414142 0.27849132568541379
0.17864002689546155 -0.52775634092763646 9.7851051564660160E-002 5.4681695700214972E-003 -0.21903969393606074 -0.18590385355178818 -4.0290196801031145E-002 -3.6287263549346076E-002 -2.2943123872634676E-002 -5.1624510284810868E-002
-1.5502801837950275E-002 5.1344072195842985E-002 -2.4384401063928841E-002 -9.6851523742089093E-003 -1.4320623720006607E-002 2.6425612005367926E-002 0.42381350006410717 -0.32735051627612977 0.22720647798437887 -9.9538570145625116E-002
-0.16116614864543233 0.36656105327597610 6.7719159922499397E-002 -7.1106194027974343E-002 -0.52576407016765048 -0.34454223714740007 -7.6814231143517882E-003 2.2509067566324779E-002 2.4359077701804878E-002 -1.8333799474857613E-002
-5.7526635488496222E-002 4.2920494416547925E-002 0.17024634635718996 4.8663173205493772E-002 -1.9042751740379681E-002 0.27425844160997925 6.5884527878174254E-002 -9.2156269166938573E-002 -0.22503243942221829 0.33933313891465555
-0.13264709163927310 -2.1889267942677784E-002 0.49611648034740319 9.4075145799420307E-002 0.23035603795986564 -0.32550897728844130 0.44460237415118553 1.1281038944797327E-002 -0.24012584722048966 -0.19573387818453070
0.53818295671195426 0.22247693139829217 0.10319249463229249 -0.47738276206359770 -0.10123425259415308 -2.7381497783369447E-002 8.4791536981926926E-003 2.8677370438531934E-002 -1.8216400656718843E-002 -3.7174846848085003E-002
4.1323881637018375E-002 6.9943634305478048E-003 4.4170706241895168E-002 4.0341406104912794E-003 -2.5412967990928508E-002 1.3979969038437505E-002 -0.16213254978673811 0.43756649710129675 -0.58060621230883447 0.29631832825521531
-0.31827665154817170 -0.21184930354743248 -2.6254596079924912E-002 -0.49191693411202336 -0.20581764306520106 -2.0992507118841135E-002 7.1544944466400738E-004 2.5355464237897286E-002 7.0798789696249129E-003 -3.2206960147041871E-002
7.9797916063361382E-002 6.4901252140440882E-003 -0.38588994994953596 -8.0791617906684460E-002 -0.20834360258675833 0.31407076764872244 0.51791680087809711 2.1925602527084431E-002 -0.28907163217042509 -0.23047669702085144
2 113 122 : spinor index, minimum and maximum band indices
-9.3695506436911151E-003 7.5733499684498565E-002 2.4686019482415916E-002 -5.8094242921977846E-002 0.37295704783030359 0.20643600480151117 -7.1794553775684250E-002 0.38035764618557144 0.40810401721281264 -1.2638059715163632E-002
-0.18663652973777231 0.32842364617546110 0.20306905992964649 5.7940656467684919E-002 0.10697122470561324 -0.33143849493666827 7.2760850822672814E-003 -5.0904580225921599E-003 -6.5981498150113893E-003 1.4149955543567381E-002
-1.0442023063700743E-002 4.0185505240142985E-002 -8.2099770048468575E-003 1.1359487974989313E-002 2.0175128059814060E-002 2.8198490276452701E-002 -0.54660088854397004 -0.37995298896305291 -0.26622929347403113 -0.54695740783133739
0.18637055759913199 -0.54900644733526660 0.12544295443774492 0.12236970653663959 7.3258125851468930E-002 -0.15306912082479862 4.4539227403070966E-002 -3.0524102222648519E-002 1.5728152636801333E-002 -5.9328084843180183E-003
2.5736115424596074E-002 -0.12699139134362378 -5.1278926189123136E-002 7.6418293551910349E-002 -0.39055458154421185 -0.22324776919982023 -5.9915806964068292E-002 0.32545664130344532 0.33914972013230793 -1.9218247134004510E-002
-4.2381977643107034E-002 -6.2779986082887138E-002 9.1027317393653634E-002 -0.41775369248594907 0.18644831367932185 -3.3972140778595866E-002 6.1645718716739496E-002 0.35796118512774450 -4.0821697270901222E-002 -0.36590017981912903
0.38001735359891986 0.13933115979689342 -0.45364992606622984 4.3793553222682927E-002 0.32818809751874300 -0.45709999383861194 3.3091971477912020E-002 5.8025106656504517E-003 -3.6485661667886395E-002 -2.1055725049016150E-002
-5.0755226644701383E-002 -1.8255189776526654E-002 -6.5315222553807241E-003 4.9158672294033458E-002 2.2061169677036509E-002 7.4677953745476240E-003 7.7497148516839668E-003 0.24764070071726407 -0.16353441090003892 -0.29943227328639294
-0.54156152515657574 -0.14192634671576770 -0.46063998693476399 -7.2458994475186791E-002 0.17304166993733885 -0.18653757615969185 -1.2534517807263348E-002 2.7601145119092899E-002 -6.1639248528129846E-002 2.8691626970120523E-002
5.6181251561768335E-002 8.8109665541669088E-002 -0.11240847099844270 0.53757673687350782 -0.20869028621867253 5.6799879546739804E-002 6.3391117643382872E-002 0.30873917261923850 -2.8456154506832823E-002 -0.29664004610724493
16 0.6250000000 0.2500000000 0.000000000 : k-point index, k-point (lattice coordinates)
1 113 122 : spinor index, minimum and maximum band indices
8.0045305356875415E-002 -6.3995311964103144E-002 -7.6952776928246799E-002 0.11073872899944971 -9.8445226556586177E-002 0.35295171645586487 -0.10754551352898072 0.19475623718800017 -0.17531892604334443 0.14672006522922446
-3.0978754443431039E-002 -0.53593983919860522 -0.14905664780390204 6.3318585198509830E-002 -0.12531827893461545 0.23039516275944172 1.5533868221324142E-002 -5.4649645703563135E-002 1.2549758653512644E-002 -1.7911504214401054E-002
-2.7931883888804368E-002 4.5530684889425709E-002 -2.5888507373275841E-003 7.9781015177029548E-003 5.8807507716464964E-003 -3.4637254559979812E-002 0.25826862264253103 -0.54371078024880226 -0.16074469483125028 0.13466874511343838
-5.0771085671528077E-003 0.41171834869292251 -0.10394389235300262 0.10923776148389450 -0.26167069726410763 0.38821071693662668 -9.7243668752808217E-003 4.2634009838210182E-003 1.5232871916232335E-002 -2.0744566830503269E-002
-5.0506512881033097E-002 3.7698762746484440E-002 5.6863807038511190E-002 -8.0449183027889379E-002 8.4508769386304569E-002 -0.32319737932589110 -0.11855038519930482 0.24195940559579882 -0.20609299154065414 0.16871635121405795
-6.7945400934845038E-002 -3.1891512610143530E-002 -0.53228048181595800 -9.5098020690197335E-002 0.30504130854981748 0.17942684371662504 -0.21397758617981069 -7.0945395866266137E-002 -8.9609497499823609E-002 -0.50318298639625703
0.57279507532864427 5.6119277859645392E-002 -3.3309656912602487E-002 0.47014056572478330 -0.22608557924031503 -5.6535455468403356E-002 -4.6645611919039383E-002 -3.5006286677557577E-002 -4.4057251700474441E-002 -7.0976407377239606E-003
3.4482987581225512E-002 2.1066548212640195E-002 -4.8638775723975222E-002 -4.8907589354705190E-003 -3.6870543618068220E-002 -6.3949461954149094E-003 0.59096037280108005 0.17669183777274278 -8.4407474245928968E-002 -0.44333037718673080
-0.42298819016021066 -7.8859386890248503E-002 -5.8710712422533860E-003 0.47433453121136088 -0.40527875538298708 -0.10711902187420116 8.4027751741790752E-003 -9.9299574562354900E-004 -4.2495167671687269E-002 1.5667966621172851E-003
3.3248911805489487E-002 1.3801405403042163E-002 0.41893571118931722 7.5133615884848945E-002 -0.27848099771042933 -0.17521239004769279 -0.26855061258815871 -7.3311628591079397E-002 -0.10387367054206839 -0.59346694363342134
2 113 122 : spinor index, minimum and maximum band indices
8.0319547731546679E-003 5.4804247414305798E-002 -0.10188393934551986 9.5590178363090680E-002 0.18573326123938402 -0.27555566961918310 -9.7564381273975501E-002 0.25508774497103809 0.20154289361034966 -0.22843868137070938
-0.28316493234476209 0.35741551241086300 6.6292179747259705E-002 -9.5083896450917055E-002 -9.4317850420164051E-002 0.41365391726084516 1.4231707029016688E-003 9.3490302882844080E-003 -1.6108737947757228E-002 1.1846953770478869E-002
5.9573956083527821E-003 4.4012693230643732E-002 9.1941714188282873E-003 -1.4849061033024294E-002 7.5257204373244723E-003 -3.6657948517452403E-002 0.23113238578094492 -0.56159160703990918 0.14348042827731564 -0.18011155610628415
0.32899137572556308 -0.50386168990801039 0.10773089533637972 -0.12752162554992130 -4.8941444463845109E-002 0.23007717290894653 2.9261942124742441E-002 -4.7984316131586796E-002 -1.8747838192418518E-002 1.4941387054148939E-002
-6.4313459394824326E-003 -9.9840999103693914E-002 0.13728872540992576 -0.11705300740938186 -0.19092157439088850 0.30164398725960684 -9.0404377376290021E-002 0.20191814914168382 0.16787370146811814 -0.19504196430225718
-3.9331073613108516E-002 -2.5550264577031488E-002 -4.1672482197616080E-002 0.41182708136669144 0.31727096711095554 9.3608746494495701E-002 0.23323924704917021 0.14527818519682331 -0.58313475433086226 -3.2867128456556802E-002
0.30910852548323858 0.22627255319381839 0.48221250623382000 4.2391848438434965E-002 0.39151824427444837 0.24822556961012404 -4.1376371233582988E-003 -8.8185323282335866E-003 -1.3163433489816060E-002 -4.3560567840824786E-002
-4.9813134539201200E-002 -5.6837353866585685E-003 1.7396280739096122E-003 -4.6388457047510628E-002 3.4408508951923156E-002 7.0891339932597809E-003 -0.52289494848792850 -0.31709302906122588 -0.44056275820592811 -2.2855514923857220E-002
-0.42678531896506339 -0.27418250624274171 0.46199127839043846 8.4062103355599854E-002 0.23212683787534838 0.11782931264881415 5.7929740655649806E-002 1.0702833688277250E-002 -4.4387895857417956E-003 -4.3304063493976606E-002
7.1208751628179037E-002 3.2489965188728362E-002 4.9581618235305623E-002 -0.52492098652096109 -0.34687067139943478 -0.10841064458861611 0.18652058858226811 0.12877664226996086 -0.49652397687781602 -2.6937710341696910E-002
17 0.7500000000 0.2500000000 0.000000000 : k-point index, k-point (lattice coordinates)
1 113 126 : spinor index, minimum and maximum band indices
3.9659015728408034E-002 -7.4166707403639037E-002 -0.40488544427015816 0.13320807927510356 -0.17425994014481480 0.42533873199858047 0.13559663664512789 -0.18551203010820611 0.17800766159220205 -0.38919829566743336 3.0992965714430453E-002 -2.1030865390540804E-002 -1.3581342021755552E-002 3.4467304547399899E-003
8.8372019074093172E-002 -0.16523713381885019 -0.12707167155920873 4.1807070194618830E-002 -4.2039537411099392E-002 0.10260618073382853 -1.2201775825566075E-002 1.6693702112656340E-002 -4.8008458657287515E-003 1.0495877443496506E-002 -4.3200159375753845E-003 2.9275140595714983E-003 8.9147441473503674E-004 -2.3001173365738573E-004
-2.2176650872212822E-002 4.1471909565665828E-002 -3.3199428778119988E-002 1.0922713484512986E-002 1.6992761065773732E-002 -4.1479394217173136E-002 -0.36803056889480346 0.50349960302716068 0.15694009233071052 -0.34313153027239096 -8.6499858788190678E-002 5.8686819307224469E-002 -1.3225756056447203E-002 3.3608693020527520E-003
-6.7031120849017606E-002 0.12533377304241228 -0.12723302698089228 4.1858531993756921E-002 -7.4812331664300999E-002 0.18258946886840760 1.7135024414172816E-003 -2.3457774086403215E-003 -4.8013433936592046E-003 1.0498571833039384E-002 1.4299370401834484E-003 -9.6965896399232561E-004 8.9309742555427555E-004 -2.2981913657687094E-004
-2.1581515975438646E-002 4.0360298414792946E-002 0.32453996173384037 -0.10677391504134497 0.16089793077740275 -0.39272250960395155 0.16569391951068235 -0.22668634961700973 0.20554852236721943 -0.44941264380084500 3.9271916012480021E-002 -2.6648512504919175E-002 -1.8702450162614147E-002 4.7474646252535909E-003
-7.3451932775578516E-002 5.1757658559956073E-002 -0.34328266934642532 -7.8891872649613975E-002 0.20868155172200931 -6.6616495566775014E-002 0.19383110403028847 -9.0859160664256505E-002 3.7580204165073183E-002 0.36254031615284155 5.4180665654361424E-003 -2.0919056117243106E-002 -5.5780737377581407E-002 -5.3914884241859770E-003
0.57052890264762102 0.50792274573707941 5.7166727879199047E-002 0.47647858711626823 -0.29504783286428415 -0.15757772986554724 5.2126853244772578E-002 5.9025205051188412E-002 4.1680483587630275E-002 9.7502211674476546E-003 -1.1152962648218107E-002 -1.2411839128582890E-002 7.5702150747155444E-004 -1.1076995360796251E-002
4.1132976738608294E-002 -2.8909193646486690E-002 -2.8059814552042144E-002 -6.1973094418980483E-003 -2.0047233673940679E-002 6.6185645352159969E-003 -0.52756054604901226 0.24552544755004457 3.2732902083276144E-002 0.31944524879511321 -1.5224696648035749E-002 5.8223546685538814E-002 -5.4309999923374749E-002 -5.2007552574746185E-003
-0.43359269639789511 -0.38571551421287226 5.6801340573143580E-002 0.47573777531995909 -0.52507903603632511 -0.28042619411221098 -7.0458279773179706E-003 -8.0908453465051190E-003 4.1680714866649253E-002 9.7480576118280562E-003 3.5249731710896280E-003 3.8637888806027348E-003 7.6566238235807669E-004 -1.1065653858140801E-002
3.9859769712978263E-002 -2.8226011461765267E-002 0.27509819909517857 6.3047519318881612E-002 -0.19203813369745548 6.1771545090138852E-002 0.23711882305246218 -0.11083000343075250 4.3972327464807490E-002 0.41889575514571331 6.7819398448292377E-003 -2.6627782460957910E-002 -7.6868271499678786E-002 -7.6140015277828812E-003
2 113 126 : spinor index, minimum and maximum band indices
-7.4502123206620328E-003 1.3929308704376860E-002 -0.11312477092160667 3.7222410389171103E-002 5.5934949820627522E-002 -0.13650579218262460 5.7592971192611038E-002 -7.8795700620713463E-002 -7.1836128444243155E-002 0.15705934982013081 1.3845842939499661E-002 -9.3800736350332578E-003 6.5483599484463832E-003 -1.6859060873077303E-003
-0.19246892373056032 0.35992709264318762 0.36424822107061849 -0.11983626441737949 -0.21467193237569374 0.52397477890442701 4.7793957670972890E-003 -6.5404562820679420E-003 1.4069847408742047E-002 -3.0762050253186627E-002 3.9312463077595082E-003 -2.6678117381961014E-003 -2.6215353662072372E-003 6.6517556203144249E-004
-7.7234345634358331E-003 1.4442295690005902E-002 1.1366280293254543E-002 -3.7399177859318376E-003 5.8143719613502265E-003 -1.4192391535268058E-002 -0.12842241851803979 0.17569767596209102 -5.4538516788823058E-002 0.11923680442577825 -3.0111133822227219E-002 2.0399228011077332E-002 4.5790730094911304E-003 -1.1810581612667311E-003
0.25331983648088668 -0.47371350830671560 0.36488609352702928 -0.12004891820989388 -0.12062681164861613 0.29442610630485921 -3.5149716182723667E-002 4.8086037608511253E-002 1.4069914657379137E-002 -3.0762814060079118E-002 -1.2553050380130909E-002 8.5162233382027087E-003 -2.6260273127679513E-003 6.6701789825107790E-004
1.3769627038063316E-002 -2.5747258539775723E-002 0.14132457104611706 -4.6499624854682238E-002 -6.0852234178863929E-002 0.14850644913529459 4.7007662143071637E-002 -6.4313332756397404E-002 -6.2027235060002670E-002 0.13561216776834623 1.0838706420269706E-002 -7.3439258815356338E-003 4.7198616616068332E-003 -1.2162716854913758E-003
-4.8680820632279978E-002 -4.3132757234444492E-002 5.0774307356492215E-002 0.42381385046773584 0.39359923218697851 0.21007790993531064 -0.24566939295024245 -0.27833900542863160 0.61015031035912548 0.13970156987683074 3.5028027065851092E-002 3.8731327940197666E-002 6.1365487150440122E-003 -7.9093110909431219E-002
0.35698822257779050 -0.25089595224653077 0.30886709846553251 7.1080696937119173E-002 0.25669759015371824 -8.2215821117989335E-002 6.9331413674902399E-003 -3.1307307019809022E-003 2.6961055347044880E-003 2.8530881353620408E-002 6.4556983873133994E-004 -2.7147410304439630E-003 -1.0753578851305279E-002 -9.7000429439789788E-004
-4.9960082520872626E-002 -4.4444612237027767E-002 -5.3390529822093516E-003 -4.3307328994973804E-002 4.1597933632608754E-002 2.2119605137938345E-002 0.54525474378522609 0.61878378794828603 0.46563273193473381 0.10716106625157891 -7.6997408621418129E-002 -8.5425897884045587E-002 4.1640638809829220E-003 -5.5877721067457642E-002
-0.47023191619877280 0.33001046944713991 0.30925487495153325 7.0739935014513103E-002 0.14424885051650055 -4.6194827186366139E-002 -5.0271670717701361E-002 2.3531237669238023E-002 2.6938575909841193E-003 2.8529410898113363E-002 -2.2455617757172817E-003 8.3965936799181001E-003 -1.0764504824821174E-002 -9.6015376155712568E-004
8.9383070791378152E-002 7.9404523874294891E-002 -6.3208447898215628E-002 -0.52878390413082821 -0.42620400340198789 -0.22772844956169377 -0.20114647278525863 -0.22764565615791979 0.52826292588604318 0.12127980434032609 2.7605474882099194E-002 3.0592817165597721E-002 4.3224841947196741E-003 -5.7397374467647283E-002
18 0.3750000000 0.3750000000 0.000000000 : k-point index, k-point (lattice coordinates)
1 113 122 : spinor index, minimum and maximum band indices
2.5494491677017353E-002 -7.8221261352998006E-002 -6.0906032524583063E-002 5.1797626826186341E-002 -0.18216448238271937 0.26771958178401695 -0.16169840426049842 0.18747500291452229 -8.8698152766413907E-002 0.20727571310335996
0.17164979048675383 -0.52732496287963637 -5.7431969591546193E-002 4.8906791222455268E-002 -0.11935367785308647 0.17546656602931629 1.5276357256664909E-002 -1.7705612557948568E-002 2.1089602289310762E-002 -4.9302439507628533E-002
-1.6444224277405110E-002 5.0470417255334417E-002 -7.2350680778009964E-003 6.1542772488437335E-003 1.0115714408544826E-002 -1.4863803348792342E-002 -0.14729997285261201 0.17078283496990498 0.23785469221482833 -0.55583281748501645
-0.12768332216124739 0.39223638291995055 -4.7285930424675778E-002 4.0273528036418454E-002 -0.22725929173872295 0.33410906967301335 2.1425000011125489E-002 -2.4834498543666674E-002 -3.5264862358250736E-003 8.2457038311605640E-003
-1.8542098020903473E-002 5.6901011365213756E-002 4.3811374999207127E-002 -3.7257002055189781E-002 0.16438830626468254 -0.24159100693788554 -0.19839391769169090 0.23001909881802884 -0.10624929447929782 0.24828656800700971
-0.11800826520984792 -3.4920541867816429E-002 -0.55457725558733850 -9.8510092351796030E-002 0.12558910708065318 0.36352654626906772 -0.10022320480596790 -0.47709431079391640 -0.21873465770303593 -6.3396895438950163E-002
0.54448616815204920 0.20101956750470903 -3.0133082272431506E-002 0.48648344404255589 -0.23937471310974609 1.9391013720189781E-002 -5.5973466249571863E-002 -1.1387233508715469E-002 -4.6807770322059822E-002 -2.7205301618997202E-002
3.8987413325032826E-002 1.0430614324493589E-002 -5.9232309677220180E-002 -3.8867602180558559E-003 -2.1574934820838446E-002 -3.0120002035022450E-002 -8.9181185758190715E-002 -0.43279150387626220 0.59081881583351636 0.17183153417493754
-0.36359447958636870 -0.13603845560594788 5.4958174346703199E-002 0.49428439171516819 -0.51054170127197218 -3.2261371213741959E-004 -5.2227837209855063E-002 6.6990936377765665E-003 8.0983177155707353E-003 4.6653041941171133E-003
6.6519307464598221E-002 1.9108611503456982E-002 0.40983262797892239 8.3696777376771364E-002 -0.13194125690530339 -0.34070846752060507 -0.12074571396768492 -0.58344742701153696 -0.26177559562210218 -7.5839315748699260E-002
2 113 122 : spinor index, minimum and maximum band indices
-2.1392515669323701E-002 6.5713914175498767E-002 -5.4588253797509770E-002 4.6480081718613446E-002 0.13790664750344570 -0.20275691836088916 0.19812059080578590 -0.22963291267656677 -0.10558782880114934 0.24684241176154953
-0.12006825092118686 0.36845937316687860 6.8315183767341414E-002 -5.8115542800004173E-002 -0.19371798589761011 0.28467122987357252 -1.4743048638569836E-002 1.7094096546871950E-002 -3.6233087160752568E-003 8.4680932001405182E-003
-1.2462377569756333E-002 3.8292249368565165E-002 6.8523766599294560E-003 -5.8358096054724022E-003 1.5949120321142818E-002 -2.3448419077987764E-002 0.14683954719091799 -0.17019582417899756 0.23841095506546223 -0.55735833477840691
0.17953876135895055 -0.55097941804805362 5.8191351033653034E-002 -4.9497044467347949E-002 -8.5787403415670899E-002 0.12605874728953781 -2.0885176812171745E-002 2.4213554542583404E-002 2.0982784719890398E-002 -4.9032199556032580E-002
3.8052606804057483E-002 -0.11688026323175577 7.2005642297485586E-002 -6.1310538779559658E-002 -0.14138182551698594 0.20787042243116488 0.16247891921319993 -0.18832207915539156 -8.8231492076883883E-002 0.20626636307433188
-5.6079141210509872E-002 -2.1217463621478607E-002 -7.3575061232087263E-002 0.40953675496461139 0.39424838183705863 5.7636287462899692E-002 -0.59503833252364857 -3.4754817620274374E-002 0.23716875828668335 0.13741244000507258
0.39741545811360718 0.11288175218426366 0.49119157595917090 -4.3345992235062608E-002 0.27221820528175966 0.48089949347834166 -2.1076886331137325E-002 -5.3800920412494950E-002 -8.7520658188487005E-003 -2.5114010522596228E-003
-5.0007554327455336E-002 -1.8006908698587225E-002 2.4536337947251791E-003 -5.9386260324656111E-002 2.9558016428455364E-002 -4.2439951427774595E-003 -0.44148544259202382 -2.6164804675853606E-002 -0.53069458686455406 -0.30821490636134463
-0.53502018499905979 -0.14949569433456816 0.48546164755394455 4.1914991587616593E-002 0.15428873976105095 0.23591209272047470 -2.6328712545513402E-003 -5.2726758455001167E-002 5.2254826869585290E-002 1.5216088663793141E-002
7.6742585469220678E-002 3.0245777289964897E-002 8.4866848340086176E-002 -0.55453211582531814 -0.42876294551377964 -7.5808347819964803E-002 -0.48617668483471488 -2.6937884836580221E-002 0.19798286896121983 0.11474039620321669
19 0.5000000000 0.3750000000 0.000000000 : k-point index, k-point (lattice coordinates)
1 113 122 : spinor index, minimum and maximum band indices
4.9055491801883996E-002 -6.3710825322332992E-002 -0.10705188919984747 9.9422880007438486E-002 -0.12040328400977643 0.36053583130571482 0.14134968560580349 -0.16973639475089305 0.19951098697792591 -0.15159653731392420
1.1365474685678580E-002 -0.52583717873852165 -0.10856728770624831 7.6934865306793429E-002 -0.13949975993157265 0.23211957697696092 -1.7431555322101534E-002 5.6039380239452985E-002 -1.4672649217295880E-002 3.3632874926998027E-002
-2.3643829232303529E-002 4.4932245987849617E-002 -9.9740544752495320E-003 1.1019244585232851E-002 9.7887127442525500E-003 -3.7228528869115707E-002 -0.27237681432932148 0.54559982994354783 0.20506240429314901 -0.16925917436336871
-1.8873953148318811E-002 0.41764902308859164 -9.1774487859638029E-002 8.9502968627445070E-002 -0.24018523794023444 0.37214579005727200 4.1228718056927748E-003 -4.1148537047347132E-003 -2.1657955637109719E-002 3.2387684824399007E-002
-2.6896239645874967E-002 3.5857296591121440E-002 7.8178924274713138E-002 -6.8657917891153109E-002 0.10470752626263813 -0.32758002637305267 0.17137339428649626 -0.21287656087381260 0.24701549817607354 -0.18316898018845806
-6.7611582371596146E-002 -3.4736488546655571E-002 -0.54875949460591056 -7.8135567449202706E-002 0.32385890622965530 0.12330180114550816 0.21025220384704912 8.2243105628100180E-002 0.13481904113192084 0.46246728661741865
0.57124887796317958 5.3315905163987674E-002 -1.5401360131154911E-002 0.47738687232820498 -0.22178263746990126 -0.12201349375972906 5.2542474202639564E-002 2.6263146100536421E-002 5.1755986495429243E-002 4.7526769703359461E-003
3.5378876968188026E-002 2.1730321779511674E-002 -6.1074781185428223E-002 -5.4977051517632203E-003 -3.9684072360135297E-002 -1.0769557198213256E-002 -0.56771196197089968 -0.21279180276010840 0.17668980183914379 0.38364080395454009
-0.44376847162463856 -5.1912334292169258E-002 1.5175577577994492E-003 0.47930537147855568 -0.37128144209371583 -0.20327688353878584 -2.7966157074647800E-003 -4.2048492513109079E-003 4.9876002960560037E-002 -7.2817232687204204E-004
3.1135584970918315E-002 1.6204796963113693E-002 0.40134855433985794 5.9302354433809421E-002 -0.29588164027876795 -0.11690984753386834 0.26392330639612060 9.7427790811901241E-002 0.16364055633588764 0.57155107116670822
2 113 122 : spinor index, minimum and maximum band indices
1.6589143707245297E-003 3.9905915920831259E-002 -8.5756764572860564E-002 7.6273721397900160E-002 0.17730509698090144 -0.27044693094656852 9.4242668657153333E-002 -0.26647779855900561 -0.23487237649479847 0.29391310869300263
-0.23425275935881007 0.38783369097590858 9.4668108766906747E-002 -8.5788242465778874E-002 -0.12848860287632138 0.41031077718498454 4.2585126808309427E-003 -2.7336613850775585E-003 2.4037780232175218E-002 -1.6202294810510307E-002
8.0716193003743935E-004 4.2235110595737792E-002 1.2271818529596698E-002 -1.3391933295246327E-002 1.7676140050928314E-002 -3.7085537971484402E-002 -0.20468600980263441 0.57165736902727782 -0.12264364199872695 0.27066290998274722
0.28418058811427138 -0.50506273934611845 0.10562849530924882 -9.5111954600891196E-002 -7.5453214484551029E-002 0.24433629419762626 -2.7098751996638502E-002 5.2278969127947841E-002 2.8565195590550339E-002 -2.2714966451862429E-002
2.3600487946983371E-003 -8.2451978543350679E-002 0.12131294886406853 -0.10413825991881744 -0.18987079844769175 0.29491254860138655 7.9702901284144340E-002 -0.21235955278670288 -0.18748251977139435 0.23912065419917075
-3.9311834815544282E-002 -1.0014601798000591E-002 -2.9602989587813405E-002 0.40171312914697382 0.29923375299415478 0.15927452848765503 -0.21432110956996470 -0.16749571486060175 0.55227363629205661 3.7589117659562160E-002
0.34964412231254965 0.21649947978873316 0.47830954458888703 3.2630333033125583E-002 0.40411055760925135 0.16488193768534867 4.0459149051394784E-003 4.1651783532210803E-003 2.1717396679195623E-002 5.1906163832782695E-002
-4.9904657285395768E-002 -5.1995491121030477E-003 1.0182469435220116E-003 -6.0417135142994759E-002 3.4487475606867719E-002 1.7185816215186632E-002 0.54868887743109507 0.26387989081755242 0.40107826732208834 2.5056318518423820E-004
-0.44563320672945933 -0.26714267147890391 0.47186879149118938 5.4572853157775394E-002 0.25114446492676329 9.4591344376806080E-002 -5.5647154385486855E-002 -1.8206187978335238E-002 1.8381993359208385E-002 4.8754766890097431E-002
7.2524324082473862E-002 1.3394790487368642E-002 3.5681023448275381E-002 -0.54931928546921105 -0.33036274362152973 -0.18002368594806448 -0.17095454374308944 -0.13826346627817845 0.44908162739902163 2.8355510523730160E-002
20 0.6250000000 0.3750000000 0.000000000 : k-point index, k-point (lattice coordinates)
1 113 122 : spinor index, minimum and maximum band indices
-5.4603334644150701E-003 6.1228601296433871E-003 1.8768017602231520E-002 -5.2095747578687700E-002 4.3815440142198667E-002 -4.1890513586437000E-002 -1.9642279773083627E-002 2.6624615083570870E-002 -6.4216639129191538E-002 3.2340677466508906E-002
-0.30240587631454813 0.33857548474314053 0.12018525370223763 -0.33449789939174157 0.23773374495323318 -0.22724007075143232 4.0286576930687101E-002 -5.4633610820494123E-002 5.0107124554481616E-002 -2.5229606554578510E-002
3.5673778832244572E-003 -4.0001588134027013E-003 1.9293617364372340E-003 -5.3565715946533579E-003 -5.1629265480541810E-003 4.9343456782240920E-003 5.4406892262427842E-002 -7.3744162723578963E-002 -5.8012717271924370E-002 2.9216558673192228E-002
0.24361365277379837 -0.27275206365073584 0.12016893149194686 -0.33444569177206396 0.37437351551217035 -0.35784716322116289 -2.5964208417156957E-003 3.5227218585294900E-003 5.0103531524562414E-002 -2.5228157977951811E-002
2.5501530743272361E-003 -2.8602082667963879E-003 -1.4040396492750967E-002 3.8970244835254318E-002 -3.9604081841769972E-002 3.7864513355957224E-002 -2.4784350661119062E-002 3.3591570359310194E-002 -7.7870922105714252E-002 3.9216722319023060E-002
6.8220707325755414E-002 7.5850442566045076E-002 0.54783154729958194 0.14054224983499375 -0.32906192255366240 -0.39465134767896903 -0.23263185127198649 -0.20369128597493139 -0.22847665407368675 -0.49478063877750056
-0.48791327896797426 0.38968444511728761 5.2004851311728884E-002 -0.34273728713225621 0.17229378623840824 -9.3144040077601672E-002 -4.0962191385934606E-002 3.5755453125382940E-002 -1.6406111155669357E-002 -5.7964401658957556E-004
-4.4537264046393979E-002 -4.9524817525946889E-002 5.6331271500899130E-002 1.4451525056366463E-002 3.8773268668819645E-002 4.6503788027766751E-002 0.64429421051449687 0.56413516293043420 -0.20641942942262437 -0.44700521077699162
0.39305303928498031 -0.31392619537248045 5.1991032921771610E-002 -0.34268644375722807 0.27131951506867785 -0.14667904647974678 2.6406140959136168E-003 -2.3056560270571722E-003 -1.6402618091110013E-002 -5.7417528365943406E-004
-3.1847614496322646E-002 -3.5413262209131505E-002 -0.40980850772252081 -0.10513350010045676 0.29743520227740816 0.35671939205660641 -0.29351290542804842 -0.25699740693849266 -0.27705804446399618 -0.59998606722026782
2 113 122 : spinor index, minimum and maximum band indices
1.8715756074983027E-002 -2.0954917324831505E-002 0.10290431343957003 -0.28640036354206827 -0.29046687355484313 0.27764251643254900 -0.18174033780354928 0.24647120365597663 0.57141836994007034 -0.28771913375483793
3.3193920873537827E-002 -3.7218667689036665E-002 -1.6393884378024467E-002 4.5509298577276536E-002 5.1047848485235719E-002 -4.8802125681332277E-002 -3.5340327752890390E-004 4.8035876245218273E-004 -6.8257404225988225E-003 3.4368167689012210E-003
2.6174496324079262E-002 -2.9305766171053790E-002 -1.4144411558272389E-002 3.9367810396223724E-002 -3.7863886742193528E-002 3.6194242769129088E-002 0.39893676874835921 -0.54102272791965766 0.42573019103136506 -0.21435801703835008
-4.1208432517519558E-002 4.6203897799791192E-002 -1.6394759014320515E-002 4.5513218154845284E-002 3.2416346239006882E-002 -3.0990189350043766E-002 5.4952129858054696E-003 -7.4474059666118520E-003 -6.8305095297521122E-003 3.4398392469020527E-003
-4.0089260575786483E-002 4.4885390781147401E-002 -0.13756291421810685 0.38285978181950181 0.32135264269318031 -0.30716522082942743 -0.14404294554967753 0.19534964526462373 0.47122193861275014 -0.23726862209444557
3.0196845874339975E-002 -2.4116577327951052E-002 4.4521631368896523E-002 -0.29345133998020084 -0.21050664755667409 0.11380159863896964 0.18478857014290170 -0.16130313256844134 -0.18707993861054928 -6.5801523509672055E-003
-0.41453753895536977 -0.46092666415627809 -0.47855726785362984 -0.12276672756699249 -0.38335870946448541 -0.45977228295233169 -4.1921954099319036E-003 -3.6720367116881772E-003 -2.4293564018640201E-002 -5.2607996021472363E-002
4.2232930015057353E-002 -3.3728805882975797E-002 -6.1202938527102034E-003 4.0336968882789370E-002 -2.7442170240573539E-002 1.4835404512785866E-002 -0.40563059494427267 0.35406862256547111 -0.13938096584102058 -4.8999397647140923E-003
0.51457697290601956 0.57216523816205045 -0.47863265140577682 -0.12279195278831702 -0.24343972494591942 -0.29196278374199841 6.5063091979138343E-002 5.6967819406015210E-002 -2.4293917493668767E-002 -5.2611471925198418E-002
-6.4678267846775286E-002 5.1664112479335389E-002 -5.9516847022423595E-002 0.39228760140972813 0.23289083151050988 -0.12590190053929104 0.14645880004571402 -0.12784480289388359 -0.15427569403848673 -5.4264840435188661E-003
21 0.5000000000 0.5000000000 0.000000000 : k-point index, k-point (lattice coordinates)
1 113 122 : spinor index, minimum and maximum band indices
-6.4073721795664756E-002 4.9802810237554979E-002 0.41759159602301776 0.10376090122404150 0.34076320073154021 0.37658349215616899 -0.21508558295009547 -0.20005084658569289 0.23612314919456975 0.45951062160795147
0.52211874575848205 5.8620265628106870E-002 -2.7351842398784354E-002 -0.45637284607940537 -4.3277853728208256E-002 6.0084321543681075E-002 -5.1680337154680608E-002 3.0259550507040957E-002 9.0168596065897510E-003 4.1549414854208447E-003
4.3275774321753557E-002 -3.3640168441072565E-002 4.9405814515949498E-002 1.2276328753096283E-002 -4.2051137417356735E-002 -4.6473480110016750E-002 0.59784484911966695 0.55600759307948122 0.21766503822520916 0.42355108180565637
-0.42557475424821556 -4.7782186077974763E-002 -2.7352954977921624E-002 -0.45631049739958213 -6.6554807672812369E-002 9.2402877151750024E-002 2.2637129801678611E-003 -1.3268940411817233E-003 9.0071690027308370E-003 4.1475199696632027E-003
2.8730241712627176E-002 -2.2333138271603745E-002 -0.29654212638576261 -7.3683357601965094E-002 -0.30646564391122888 -0.33867974535103268 -0.27368879047129052 -0.25455691326633151 0.29629536783696669 0.57660935606833108
-1.3832077236482452E-002 -5.3500591819728216E-002 -0.37572831726462774 9.6632070833921294E-002 -8.6168846110556974E-002 -6.4337832020830599E-002 8.6580752659536186E-002 -4.6225132090612527E-002 6.9393866601097261E-003 0.14945057774835882
-0.23472799209330836 -0.50998407696385051 -0.11806603390836184 0.14919665207301894 0.28275680156647370 -0.25622447995601516 -2.7182116177510235E-002 5.8588079565246295E-002 6.0979092132147882E-002 -2.9845125236064928E-002
9.3448284401210380E-003 3.6141395009797100E-002 -4.4452434423086169E-002 1.1432631233263482E-002 1.0632993209995119E-002 7.9381866637323259E-003 -0.24068702460059618 0.12851435052056881 6.4107009525619279E-003 0.13775247092825255
0.19132623275068167 0.41568794242146134 -0.11804798912605458 0.14917479437002210 0.43484707579630760 -0.39404308437147251 1.1903657136789897E-003 -2.5690091268479355E-003 6.0929039264255615E-002 -2.9824954775771077E-002
6.2034414969913982E-003 2.3993685762533606E-002 0.26681546082499985 -6.8620804972892399E-002 7.7496359743845195E-002 5.7862261118620160E-002 0.11017281887485508 -5.8818938292458690E-002 8.7077502149064435E-003 0.18753497869596361
2 113 122 : spinor index, minimum and maximum band indices
-2.9895165934383766E-002 -3.3551757209760330E-003 -2.2728814715451854E-002 -0.37915841166564601 5.1979437194159345E-002 -7.2168634421758512E-002 0.23123131126269389 -0.13540162549614454 8.8679320657932950E-002 4.0860236117788849E-002
0.40900012610245956 -0.31791705129224646 -0.35688042090669186 -8.8673112887643790E-002 0.39238325416350928 0.43362982972691527 -2.6765443428242823E-003 -2.4919753266908415E-003 3.0098243631214341E-002 5.8572048221505718E-002
-4.5033753400820532E-002 -5.0554274941304366E-003 3.7859604070953714E-003 6.3169758692342370E-002 7.1333941710704386E-003 -9.9027936450326766E-003 -0.50506604900294128 0.29572318471629977 6.5146871773749143E-002 3.0000599549262066E-002
-0.50177896200772032 0.39003521997907609 -0.35693210660019609 -8.8691468011739188E-002 0.25514457529517720 0.28196415919352730 6.1173564661522711E-002 5.6891929083619459E-002 3.0120946499776383E-002 5.8614191088465495E-002
6.6663537374050064E-002 7.4871903280187679E-003 3.2006421755634056E-002 0.53393326787675122 -5.7797212615865984E-002 8.0244703522214758E-002 0.18171857846023495 -0.10640805128945464 7.0669707538496315E-002 3.2562358186142649E-002
1.3439614059686966E-002 2.9199415781667883E-002 -9.8088236102413601E-002 0.12395668672815167 -0.33963421993580994 0.30776424459963181 0.12162216288935179 -0.26216985833138196 0.59979618432889958 -0.29360109209400442
8.8307945348395658E-002 0.34153870384286705 0.32110237705551975 -8.2583033569046699E-002 -9.9219158118334067E-002 -7.4084073362820940E-002 1.0760934437158351E-003 -5.7507152976814333E-004 8.8714809328664841E-004 1.9047760668859704E-002
2.0244566039781378E-002 4.3985479879760189E-002 1.6341940637756333E-002 -2.0651788706728083E-002 -4.6601454274426760E-002 4.2230201261554808E-002 -0.26564553419807696 0.57258977295493629 0.44065063431230184 -0.21566610857485613
-0.10834339569992694 -0.41901908264615911 0.32114717511478325 -8.2594401719645105E-002 -6.4516326556856463E-002 -4.8172770763752329E-002 -2.4629186750098411E-002 1.3150772413525268E-002 8.8405595377454981E-004 1.9064414814556566E-002
-2.9971602727717019E-002 -6.5120732289117161E-002 0.13812859591992260 -0.17455477666899669 0.37764362314743344 -0.34220734820071286 9.5579856630814530E-002 -0.20603481676818827 0.47798852567859812 -0.23397623792843236
22 0.2500000000 0.2500000000 0.1250000000 : k-point index, k-point (lattice coordinates)
1 113 124 : spinor index, minimum and maximum band indices
0.10228795579948756 8.3434336514872115E-002 0.51088873365975052 0.17204950097178970 -0.22036525679093052 -0.44937073807608635 -6.5294869823071894E-002 -0.46060119109209580 -0.32893305322774929 -0.30331889353811797 -3.8189661947475945E-002 4.1060645480316300E-002
0.15746181625092140 0.11259738002696978 -5.1050950395753747E-003 0.46219663377382314 -0.19048220490651749 6.2449998050373393E-002 3.8067067942376600E-004 -2.1994563150156573E-002 -2.5741793119061638E-002 3.1369184794467979E-002 0.10204842817866043 -1.8330840127564779E-002
5.0094421700791064E-002 4.0066484742154407E-002 -3.8609806172892364E-002 -7.9016207838148306E-003 -1.0955338082789364E-002 -3.5870089897434343E-002 -9.3397335433152234E-002 -0.66293491296642537 0.51229042768770761 0.50731744230050979 -0.13382296638128066 -7.7447791686139758E-002
0.14730510037554709 0.10878614371068529 0.15270938830727043 -0.41852653301743170 0.40198692627051114 -0.25592409265721550 5.5405658684611571E-003 2.5923917659911259E-002 1.5009063269540341E-002 -2.0913870500721771E-002 -9.2989978331088088E-002 -3.1101979422343022E-003
-5.7213067629644968E-002 -4.7103621593358964E-002 -0.40590484350770295 -0.14437421335187342 0.21926195405758639 0.41400448868188872 -7.8371937364485916E-002 -0.55128190599736893 -0.37738434011714200 -0.34610909396860529 -5.2620929745325937E-002 4.9231146094981255E-002
8.7196522003970753E-002 -0.10984207431448913 -8.9105371159315834E-003 2.0698953560043292E-002 -3.2337170249335231E-002 1.9082243732243070E-002 8.7347038607036021E-003 -1.2651826755381086E-003 -4.0607348041114431E-003 4.2217198589558150E-003 1.5914284848553681E-003 -3.3319340194245444E-003
-0.48459644740668983 0.61043811154495276 8.6415547854525168E-002 -0.20074145951619846 0.16427524427601353 -9.6918365110448296E-002 5.8656392104947302E-002 -8.3823180471141161E-003 -1.7944958793499645E-002 1.8678691453165464E-002 -1.8012732235221807E-003 3.7671049060819285E-003
1.1656856732506644E-002 -1.4682695966862343E-002 1.6231197709883206E-003 -3.7699083346412598E-003 -7.3760589018411612E-003 4.3527074480693940E-003 2.2332569480058871E-002 -3.2142655751763271E-003 -4.8453844656942639E-003 5.0498991397916618E-003 -3.6146540647747358E-004 7.6151831403766565E-004
-0.31851580201905216 0.40123477567866506 -9.0118468392660175E-002 0.20933175979231103 -0.39960085037829945 0.23575383950426135 3.0561684170829495E-002 -4.3662894866109657E-003 1.1301797316965685E-002 -1.1764510221961665E-002 1.1091709067228821E-003 -2.3206164564161195E-003
-6.5808682961811762E-002 8.2900727907030056E-002 5.6513361660969928E-003 -1.3125612192331977E-002 1.8056767788330829E-002 -1.0657049528402008E-002 6.7489851319853219E-003 -9.8372107125545413E-004 -5.2619711103517189E-003 5.4722254204343061E-003 1.9945086078024454E-003 -4.1784656374642707E-003
2 113 124 : spinor index, minimum and maximum band indices
8.3478135142567467E-002 6.5091795694562526E-002 0.12249968473767407 -0.36382102536443878 -0.30398691463830541 0.14445294008041368 3.3358789223752232E-002 2.1323847217777150E-003 0.28852839246123657 -0.32065203878520782 -4.9398595369284141E-002 -5.2629693683946363E-002
-0.39984648920814514 -0.32033042266649647 -0.46793235795042420 -0.17699292054409271 -0.34782518955912800 -0.56678630920980511 -2.8365696040010156E-003 -3.0833854054663386E-002 -2.3954880874787969E-002 -1.8733079745550621E-002 -2.9437795631387931E-003 9.2845727102158257E-002
-1.5181320379562709E-002 -1.1030802046933248E-002 5.3126501675643811E-003 -3.5102620254913973E-002 2.8730204235548017E-002 -2.7014636005871394E-003 4.2144426710445049E-002 1.6811542729571548E-002 -0.42996602398772205 0.42882053575840540 7.7311882983223792E-002 -0.13348276071548912
-0.60898918990004736 -0.48651721346197363 0.50288484776595144 4.3950930096258209E-002 0.11235776506575848 0.25107544575777641 -9.6608487596541170E-003 -5.8577275826341528E-002 3.6489535069088100E-002 3.1354406230296845E-002 -1.8546401239294873E-002 -0.10193053337564005
-0.11087051942526302 -8.5915810322277908E-002 -0.14367697085397363 0.45874217552853486 0.33519890719540912 -0.13527759152037391 2.8312408257165529E-002 4.8837128562222122E-003 0.25316592863368065 -0.27920051842796462 -4.1190833066403566E-002 -3.8205270163296182E-002
-4.6065244275531034E-002 5.8026189450944288E-002 -7.7516910231919423E-002 0.18006589460344619 0.28126255996078081 -0.16593603703280455 0.55027484259240278 -7.8637348658564088E-002 0.19124284841425038 -0.19906199504149921 -7.7654406258654532E-004 1.6300989017510288E-003
-0.11377689743924375 0.14332654097871986 4.5480392539117478E-003 -1.0566150138044461E-002 9.7110260496512564E-003 -5.7257722356830812E-003 2.6135092218710840E-002 -3.7344193748617034E-003 -1.3698483081567043E-003 1.4251635364745767E-003 2.5276434116367824E-003 -5.2940186805469306E-003
3.9879356848957347E-002 -5.0236205196239621E-002 -6.9571653220576700E-003 1.6162122655524046E-002 -2.1913555510319409E-002 1.2927747387746815E-002 0.66159927983970723 -9.4542528065319029E-002 -0.26930553899305015 0.28032555874759274 -4.5765638102288793E-003 9.5714613884455135E-003
-0.12019392829934035 0.15140960619627911 -3.2106375018337220E-002 7.4584213124417056E-002 2.5845508003239270E-002 -1.5249335836794019E-002 -2.1463484497507332E-002 3.0655810417264725E-003 1.1835008012958030E-003 -1.2322178586312567E-003 -2.4970058425371668E-003 5.2285177888239855E-003
8.2057079729507501E-002 -0.10336539708755429 9.6876965877362525E-002 -0.22503738189235190 -0.29990600901785386 0.17693489946462823 0.45973368669082670 -6.5697751551805156E-002 0.16711528779873674 -0.17394915608128811 -4.9518424425167246E-004 1.0412581316268993E-003
23 0.3750000000 0.2500000000 0.1250000000 : k-point index, k-point (lattice coordinates)
1 113 122 : spinor index, minimum and maximum band indices
1.3637874621094757E-002 1.3184626176486622E-002 7.8742863553403888E-002 0.11830223608701723 2.4676501163014428E-002 -0.36912834022746333 9.9029952549927677E-002 -0.27582849849140545 -0.15529078139550129 -0.21724769388228321
0.44363140709981280 0.37941700563488490 7.1376111098305134E-002 0.43735879515777898 -0.13405908591449997 3.2950936728707636E-002 -9.2951210905935812E-003 1.1434091959119458E-002 -4.2441380433977355E-002 3.3579941636884061E-002
3.7870093857588702E-002 2.8975072744245160E-002 -5.3095219645610103E-003 -6.9403127436332328E-003 1.2048631260492835E-002 -1.3243943272671610E-002 8.6502339802542419E-002 -0.23181565274107865 0.39488074343224172 0.58077914789197493
0.34237537981640637 0.17467236473133133 -9.8869904058567937E-002 -0.41361959666098513 0.44455108499183837 -0.32371526270026657 -1.4482188927719981E-002 2.7262581605824746E-002 2.2634323404384718E-002 -1.6125912834576532E-002
-7.8974118163190488E-004 6.0240222491429705E-003 -6.6277021691376128E-002 -0.10812855425170542 2.2510676412728532E-003 0.32932751661063508 0.12268746768436818 -0.31788831382202598 -0.18812688142894884 -0.24927487980300372
8.3316487980058807E-002 -0.19952673802669454 -0.42399811103952367 0.17191866285155932 -0.26488914516707907 -0.31948659621042363 0.11548279210714221 0.45548062703549058 0.18766271856894562 -3.2287416629454745E-002
-0.38069991350904203 0.46813461760835529 2.9071052928874269E-002 0.24655467576287257 -0.10302693620904793 -2.0327370925019381E-002 4.2210236204814101E-002 1.5966571050135936E-002 1.2290236301393549E-002 4.1482578252837285E-002
3.1712979342828705E-002 -4.0092769464926105E-002 3.6271935416441345E-002 -8.4691103366104289E-003 -2.0299853898702435E-003 -2.1146043573284048E-002 0.11314946386859431 0.41948878344807844 -0.48947102123856373 0.10032788661758674
-0.15210375925338643 0.22543479209506800 -0.28246981552068451 -0.33743872556507126 0.31226844045812396 -2.6019789293750550E-002 3.4229337595235547E-002 -1.2130424254476253E-002 -1.4521547373865223E-003 -1.2233177010866340E-002
-6.4230689825494763E-002 0.13154006169307961 0.31884607226959616 -0.13691481979596448 0.25082011982427610 0.29674221691437019 0.13166411772126205 0.55258657026350821 0.21004116335760314 -4.6625309282723786E-002
2 113 122 : spinor index, minimum and maximum band indices
0.13164284054132758 6.4138837875952981E-002 -1.8235039013065734E-002 -0.27011750949028857 -0.34259297091964880 0.24834393326947060 -0.19969153848420615 0.17992871974368119 0.24647243438333466 -0.19893140327290848
-0.23666591205868798 -0.12874431696157176 -6.0363138232462928E-002 -0.12651049058639413 -7.4059932930376923E-002 -0.37514890297974401 9.1455895481277159E-003 -1.5842876176068454E-002 -1.5458255209591635E-002 -2.2679089872057905E-002
-3.8054196649837793E-002 -3.4186873945585498E-002 -9.4684919093436081E-004 -2.9132949155885154E-002 2.2887623461759939E-002 -2.0851702247813353E-004 -0.15793035660586396 0.14200199349187553 -0.57468633993328300 0.42012208278240742
-0.49258679990680737 -0.35001067369004357 0.14082708314202902 -3.0782295183546866E-002 -1.5180792420867992E-002 0.12189143864107804 1.9521873906168666E-002 -2.5249448974200017E-002 3.1346859990257513E-002 4.3029789095632313E-002
-0.19818394462257571 -8.4045310630790876E-002 3.5400058537442963E-002 0.35247779239554089 0.37102502541563365 -0.25823453660260254 -0.15539481583340634 0.15209399029616699 0.21524456375928580 -0.16496111246951523
-2.8334857211317396E-003 -3.5317862420244490E-003 -0.17350401290353504 -0.18191032775206484 -0.28132821146859477 -3.5227866116360543E-002 0.60541747677398761 3.5927171721843129E-003 -5.9692550465094613E-002 -0.19983445734165931
-0.15912068852850411 0.35183300718185229 0.53037650048439189 -0.27120783535250292 -0.31620213493927829 -0.39294482327039593 2.8402575050281341E-002 3.3620805798438611E-002 1.3064755029977344E-002 -2.5765910241032017E-004
3.1604120512031778E-002 -3.5652936118975451E-002 -1.0907638655867682E-002 -2.2252546317185845E-002 9.9373057484421316E-003 1.2215847218232883E-002 0.45250884812615844 -1.1017136211365903E-002 0.13078977491289023 0.46798763537859989
-0.34708663498746462 0.46821763763035684 -0.48191301361657990 7.0663989636852886E-002 3.5613302029954386E-002 0.11717415765731473 -2.1300988955948834E-003 3.5079536046030896E-002 -4.3194620132191122E-002 1.0037024911713955E-002
2.6568438949673458E-002 -8.0054741216774149E-003 0.20566277228037114 0.24846396055115344 0.31728690717713703 6.3954715999110748E-002 0.50931068491747988 -3.2408769002223929E-003 -4.3687060060465160E-002 -0.17921908209287427
24 0.5000000000 0.2500000000 0.1250000000 : k-point index, k-point (lattice coordinates)
1 113 122 : spinor index, minimum and maximum band indices
0.11521014984109954 0.10397865564979411 0.28067852096291507 -0.10152285474147112 1.7263590498177089E-002 0.43038970225804446 8.8853246217343473E-002 0.16344472713885536 -1.6793330858143754E-003 4.9489063769729662E-003
-0.66698046423007251 -0.53756357770401997 0.22038260535670862 -0.28254903093907724 3.4155003377238591E-002 5.9558526914286508E-002 -1.8526074652959260E-003 1.5694076355576764E-002 -4.8953840453274368E-002 6.6274299422477770E-002
-4.0822515003022107E-002 9.5534386631242404E-003 8.7868530530030593E-003 1.4288649860930118E-002 -1.0623876734318770E-002 -2.7256051093148617E-003 -1.3741937264487546E-002 1.6156461881306219E-002 0.54118767608083207 0.45170028137857388
-0.16285707064202409 0.16011260962365975 1.6314578237246163E-002 -1.4118191250374723E-002 -0.48273409486209024 0.31168608336625092 -9.8949645846843660E-003 1.9854683121816062E-002 5.3257371482179350E-005 -8.9317463665347652E-005
-8.1126942039409233E-002 -6.6821350327941426E-002 -0.20187082339250759 9.6117921743457999E-002 -3.9695075304829408E-002 -0.38647670297469777 0.10404254573959362 0.19366148426460419 -1.7058522636643314E-002 -6.8742566019066621E-003
0.10477178313164907 0.11406881153071430 0.30912407303644429 -0.12675665090715574 0.30531482060997600 0.24432283348748554 -0.12931425516182479 0.60113831288013875 -2.5976458582845372E-003 6.1059084906090718E-003
0.25247017356845086 -0.24773560798830185 1.7012872094892051E-002 -1.4767323365133589E-002 1.0847165208480405E-002 -7.0192742878811831E-003 -4.6302743177965740E-003 9.2731696773485327E-003 -6.0450741169561940E-003 8.6715334335841811E-003
-3.0181551420274875E-002 6.0207125580606230E-002 -9.0374134508715096E-003 -1.4069600900685961E-002 -6.6818037420338832E-003 1.3892638178980572E-002 6.2154332925959573E-003 -1.1312978320661498E-003 -0.54917239675364427 -0.44021600272318512
-0.11001437828505344 -2.0525842080607939E-002 0.18747183745961488 0.72160868660424260 -0.21057133981201026 -3.2698294571874571E-002 5.2715238654894886E-002 -9.3310517625138784E-003 4.5815222282174287E-003 4.2165169520993620E-003
-6.8795158332987369E-002 -7.8841509366258472E-002 -0.22389855089056263 0.11564447654450950 -0.27161709531698691 -0.23665548254849797 -0.15558611345987164 0.71453477510597374 -1.7833958810433644E-002 -5.9473955794675749E-003
2 113 122 : spinor index, minimum and maximum band indices
-0.10146933697029976 9.9729832501865637E-002 4.2508735839913488E-003 -3.6079416225334960E-003 0.39637314711689825 -0.25591156170549895 -6.4674803836418701E-002 0.12983915616280023 1.7978778382241683E-003 -2.6038323699974319E-003
-6.0597029465078361E-002 -0.17572995997255184 -0.48734550783596542 0.11160637533446563 0.12513013310146512 0.42110710534876139 2.1188292716272733E-002 1.9032754937670419E-002 -2.6472908121050465E-003 2.7578754915690354E-003
5.7160336063157409E-002 4.6317332672761932E-002 -2.0023041464486895E-002 1.2566498452005845E-002 -1.0746966994894710E-002 -1.1049205748230850E-002 -1.6099588747325724E-002 -1.4626506662245834E-002 -0.62658179591237162 0.76400817350471684
0.47943675594189561 -0.10688310822781369 -0.20234238945696592 -0.15419129749605678 2.3241184496898500E-002 -2.6271356511945176E-002 1.3814169535451353E-002 1.0076939697536789E-003 4.7146265371434161E-002 3.5045521556939171E-002
0.15038651277245460 -0.14779472871447996 -7.5337761601391353E-003 6.4603576945300506E-003 -0.42468323678122627 0.27418094580858215 -5.4921547437542892E-002 0.11025609729162572 -1.9003717596313100E-004 2.5295251735193980E-004
-1.9592924121781086E-002 3.6989181410752539E-002 0.15031084361189659 0.30144427500386561 0.21968351464450370 9.9302902890061884E-002 0.73748357919965135 0.13480976079763277 -8.9076493208840035E-003 2.4542858227911343E-002
-0.14961660831665524 -8.8032276694352263E-002 -0.53235782170663359 0.15150534296284124 0.28733314606050020 0.31630049238822089 5.6852357882832827E-003 5.0144456579089516E-002 -3.2831766189862187E-003 3.6586773614253922E-003
-2.1185046320453513E-002 2.0788168377448235E-002 -1.1226737941065117E-003 9.7893899692966442E-004 9.2184121006741431E-003 -5.9513690885158576E-003 1.7346722180721433E-003 -3.6840913583732430E-003 -7.2239632445858890E-002 0.10375886202994612
0.34712278815342756 -0.70510847305824220 0.19776484167471958 0.15835746515246196 5.5287106184266077E-002 -2.4375619618681815E-002 -1.1893457004606513E-002 -4.8845334075637258E-003 -4.7378384703835735E-002 -3.4710171408368032E-002
3.4712158338395284E-002 -4.9061205355038023E-002 -0.16222388916078309 -0.41748870001831839 -0.25411706254407895 -0.13542764592706341 0.62053596898125762 0.11162695885482646 7.8588462671770436E-003 3.0819385982086885E-003
25 0.3750000000 0.3750000000 0.1250000000 : k-point index, k-point (lattice coordinates)
1 113 122 : spinor index, minimum and maximum band indices
-7.3784515863543010E-002 8.4247623318330467E-002 4.8457498373752864E-002 -7.5092688010048522E-002 0.13243710177558077 -7.5746094186146237E-002 -0.12141154572184115 5.9328702275096207E-002 6.3723267708820919E-002 -0.12807789786349352
0.57433096781491411 -0.65576528765001418 2.2610737784390166E-002 -3.4865486969977294E-002 1.1862503975726885E-002 -6.7851714941001839E-003 1.4249529454816114E-002 -6.9596433347897920E-003 -1.4953379846904482E-002 3.0047997768062183E-002
-1.4443505483336814E-002 1.6490533819709850E-002 1.1742349057940215E-003 -1.7536355935666513E-003 -5.1569192267174220E-003 2.9505684685887188E-003 -5.8947241268430546E-002 2.8805173785568024E-002 -0.30914553860906663 0.62133919362238754
6.5351520302555643E-003 -7.4689292445104249E-003 -7.5823927476704578E-002 0.11324454347595697 -0.43505778351386015 0.24884406528639957 3.3126940089351936E-002 -1.6181481106088864E-002 2.6587101297106969E-003 -5.3432996006958933E-003
4.4755425330244979E-002 -5.1102625149628045E-002 -3.5105041605062268E-002 5.4290773517878962E-002 -0.13350317582140164 7.6355955695503921E-002 -0.15025711447606932 7.3422942629673471E-002 7.4955159506152724E-002 -0.15065055917990891
-4.1360786724704161E-002 2.7638073788133537E-002 0.39987402724699606 -0.15392895192290260 0.29817268105594447 0.52947347995122584 -9.8926110789193319E-002 -0.57788560777259734 0.13154911711309028 -3.3293410984640476E-002
0.42528522864020291 -0.12462062694502957 0.15248990922387867 -9.3464231629432293E-002 2.3995989540707731E-002 4.2686237975639682E-002 -2.7216887529561404E-002 -1.1668276706159598E-002 5.2351097358687551E-002 4.9216115853887396E-002
5.4389813502054615E-002 6.0137026930870065E-002 -3.6615787595104150E-003 -1.2210622302370487E-002 2.8051887609547785E-003 4.5857303944097910E-003 -5.3136514642889203E-002 -0.29102990284134639 -0.62535064874378321 0.16789990160694415
9.7305441404341747E-002 7.9565063490475568E-002 0.22746207169647042 0.78268601182869402 0.11823711724983987 0.17987928243372769 -4.2924979765774335E-002 1.4534104173284268E-002 -1.0861861261986547E-002 -9.5244725463968817E-003
3.1845060397721107E-002 -1.0846343843767604E-002 -0.26783028634188366 0.12538721908572362 -0.26086227157924630 -0.46430799233308678 -0.11836590864444214 -0.70686270743487856 0.15440428788597196 -3.9324710222361683E-002
2 113 122 : spinor index, minimum and maximum band indices
-1.0178542261464274E-002 1.1621807096832623E-002 -2.1684890714250369E-002 3.2042223719653831E-002 0.46211563735749478 -0.26432094618275964 0.39153401316938663 -0.19124186267653959 4.5752230384226260E-002 -9.1937891877593644E-002
7.6069349536968284E-002 -8.6856313531081739E-002 -8.3300883129721892E-002 0.12958353544397044 0.18642909800487809 -0.10663037381358451 -3.2930044573290674E-003 1.6102913612921965E-003 5.2921151633145893E-003 -1.0637442763857492E-002
-4.8764479179396844E-002 5.5679373202485817E-002 -1.3129967636718027E-003 2.0410792114190163E-003 -4.6630278880768795E-003 2.6665824898499794E-003 0.16230329460285595 -7.9274708094091095E-002 -0.18383985975185108 0.36942039075848404
0.14400126505983563 -0.16441570692742002 -1.0734266675745806E-002 1.5703086885604164E-002 4.2491945155386568E-002 -2.4304264895587561E-002 -1.2780644495675888E-002 6.2436538285225137E-003 -2.6068846459522184E-002 5.2393439230558558E-002
7.8144753043211546E-003 -8.9213766877317760E-003 3.4805115113220535E-002 -5.1669294539292684E-002 -0.52727438115220504 0.30159030343608545 0.32063319201724083 -0.15661070831454865 3.9015464064752030E-002 -7.8399997211047498E-002
5.1235719553277735E-002 5.3684312855754014E-002 0.13490140153148331 0.26821145348911629 -8.8675170626905289E-002 -0.12651936124389224 -0.59308281596167101 -3.7788709068890904E-003 -0.14882337610429408 -0.14493642714590366
2.4509175367820546E-002 -4.4375752591288897E-002 -0.78643270275857091 0.20172961102196363 0.24397779081176543 0.43805152280511650 -2.1499006223898515E-002 -5.4196630804907074E-002 9.5514435601060689E-003 -3.4490043547907943E-003
-3.8863326394302393E-002 8.1696341770303403E-003 -1.2267374828709042E-002 3.2592500747137495E-003 -2.8261200962206752E-003 -5.2296208829741521E-003 -0.24328093489987795 3.6951713504869426E-003 0.61681153584156057 0.59174525724941152
-0.65178618678962241 -0.69547958532267395 9.9177393620526966E-002 0.15334110383951155 -7.9166375615254136E-003 -1.1222351206953779E-002 4.6074114303650965E-003 -3.0080102624506812E-002 -5.1434709174095039E-002 1.4803217310664947E-002
-8.8314869005704955E-002 -8.4112795763661707E-002 -0.16769227147993662 -0.39947096194757586 8.9797457714085052E-002 0.12446161834179575 -0.48442315858803986 -5.1485636544019000E-004 -0.12645055466736804 -0.12336773707717845
26 0.5000000000 0.3750000000 0.1250000000 : k-point index, k-point (lattice coordinates)
1 113 122 : spinor index, minimum and maximum band indices
0.12223439197629024 4.3773521191336769E-002 0.39371134377350470 -6.4245707072591043E-002 0.37133682623226150 0.48002191716311260 -0.18158234615077087 -0.59270753785133312 -2.3900694776662389E-003 1.2130626321170590E-003
-0.52920009310519922 0.60456890574456590 0.10316578697685523 0.46931218088610482 1.4908993114289681E-002 6.4736526538350048E-002 2.5071515043366202E-003 -8.4098440480347633E-003 2.6298896567531222E-002 -3.0276165338512066E-002
-4.7038034649629620E-002 -3.8569257311395815E-002 4.5279435842350911E-002 -4.6796945341877026E-003 -1.1403883743524558E-002 -1.1553576305715726E-002 4.9079927280101365E-003 1.9740879289617199E-003 -0.73690362778878182 -0.63547400285288524
0.27413840041806198 -0.37656490062615189 4.3018545649727888E-002 0.67536984282581958 2.6643641350673365E-002 0.16002148890888351 4.6152199622606811E-002 -8.5926122330847350E-003 3.7904029868403473E-003 -2.3514859740632194E-003
-6.6454893625050304E-002 -3.1720358476646261E-002 -0.26885318356595100 5.5874042839154363E-002 -0.31711407905163125 -0.42447060373412537 -0.22370349459383895 -0.73088919381170858 -3.4196171140665416E-003 5.2476234620588667E-004
5.4851263255966003E-002 4.0790331043265945E-002 0.15710966100746340 -5.8073412228766476E-002 -0.16065785566967661 -4.5727081711186376E-002 8.8414850511990509E-002 5.4405186432294056E-002 -2.8170693117696285E-004 -2.2952121205786205E-003
0.26655040439803757 -6.5849820363104106E-002 -5.7397991477410613E-002 0.11255229650548622 9.3861881982314072E-002 -0.10517447816671598 3.3323704445482535E-004 8.3112398425217188E-003 5.0650855505531112E-002 -5.9949383663649630E-002
-1.6794953565943006E-002 -3.1558907062033355E-002 1.8435632637737325E-002 -9.5566247176283193E-003 1.1473078056923320E-002 2.6781691307839429E-003 4.0570671040319108E-003 2.7766163280658613E-003 -0.15629979259832577 -0.14415333167566538
-0.15948563897801138 5.4746140567983603E-002 -4.7010681599473435E-002 0.12352354973760209 0.39963763421999754 -0.29889602354179268 -3.5955005809620799E-002 1.4602934721098611E-002 5.0005244041462296E-003 -7.1061403203685203E-003
-3.7034667917749280E-002 -1.9271837947034094E-002 -0.10830790495193363 2.9512955448267687E-002 0.14837627605124604 3.1241367821733670E-002 0.11103606583216431 6.6851299848922893E-002 5.9234111565373039E-003 3.6642569089085147E-003
2 113 122 : spinor index, minimum and maximum band indices
3.5420708022636048E-002 -7.3408158215351543E-002 6.3028531875364724E-002 0.28546094744316941 7.0001757861101318E-003 -0.13006277437548366 0.54980480328505599 -0.23421033859453289 -3.6738929815081367E-003 4.8631145187359569E-003
-0.35236188790294776 -0.22775898270289932 -0.63854496594733123 1.1655064390399112E-002 0.28929515565363895 0.40051041811545784 -1.6520867966665759E-002 -5.7816034473797226E-002 -7.4723414501180092E-003 -5.7996384318655010E-003
4.5024873751973962E-002 -4.9697391312467011E-002 -9.0251236260181326E-003 -4.8179508995663492E-002 2.0170476508679989E-003 -1.0804675150874956E-002 6.6534111350218601E-004 4.0218389246811164E-004 0.30108550280089813 -0.33863771511209750
0.57100950929331418 0.44960370105488479 -0.45785200769157419 5.7211503892065071E-002 0.10131611371581574 9.4558382688113868E-002 -1.1816078023104240E-002 -1.4762907596866000E-003 -6.5679799634697708E-002 -5.5674366717295448E-002
-5.2293193997881800E-002 0.13183558282545368 -8.5235714655421124E-002 -0.41724220570346482 -1.8297339702840369E-002 0.13923447984650503 0.44600019324679746 -0.18886302120116827 1.9145316605968989E-003 -8.7766361898577051E-004
-1.1080126971832064E-002 1.9975024787337221E-002 4.4926045854015518E-003 5.0226426317615869E-002 -0.42556311679253367 0.32505553899065814 -0.48619224994531707 8.6705572572891909E-002 4.2933810160267411E-004 -4.8089594828469948E-003
-0.14366200116282216 -0.22071291285774502 -0.25226688815388221 6.2645204297338219E-002 -0.17679187385369186 3.8275563546003805E-003 -3.7581186017594699E-003 8.9429058293830285E-003 -4.6669258950682562E-004 -2.3932544674462623E-003
-2.1361340732781522E-002 4.9940248456046259E-003 5.6360879634346616E-003 -8.2942715554450118E-003 -1.1686256445678079E-002 1.2039607571841381E-002 3.3387204589683714E-003 -6.3610625984161862E-003 0.57788821348869068 -0.67289009993568949
0.20925621780432527 0.38594892511111906 -0.15262461256260201 0.10327224634132193 -7.0624441704969260E-002 9.5371962675783878E-003 4.2188925629112434E-004 2.0538560981970050E-003 -1.4026695916683811E-002 -1.2547372691390373E-002
2.9069210358631276E-002 -2.3860090864672490E-002 1.5322267909418125E-002 -7.4826690363651555E-002 0.48184933654925388 -0.37989070273918074 -0.39413934961224451 7.1554037673851101E-002 -1.7526687793763185E-003 -2.2340163891237585E-003
27 0.6250000000 0.3750000000 0.1250000000 : k-point index, k-point (lattice coordinates)
1 113 122 : spinor index, minimum and maximum band indices
0.10023735262395490 -4.1158475778434289E-002 -0.25611462918927730 6.1532884974592840E-002 0.21599844294596238 -0.42109105985048051 5.1530280233738908E-002 -3.8948227147904434E-002 1.2266369654280155E-002 -1.3147837609403218E-002
-6.9035013044996013E-002 -0.51394864451001254 -0.17486741494165259 -0.49965902157931558 -0.19431571225450633 -0.16145397695278285 -1.0766038303889471E-002 2.7901286938269005E-002 4.1602816639076508E-002 -5.3663225499801653E-002
-3.7980534102251107E-002 1.5601693970959628E-002 -2.7343883871214350E-002 6.5701646263571362E-003 -1.3832102347312804E-002 2.6963964231246657E-002 -4.2881140770342614E-002 3.2385083460074481E-002 2.5394681651375976E-002 -2.7187850156395781E-002
5.8584224501444480E-002 0.38891507422840793 -0.14223258112322251 -0.56101790859393719 -0.42900573277861170 -0.32136993810508152 2.2892144479714261E-002 -1.0022128068966050E-002 2.2001486500764035E-002 -2.7619693533566123E-002
-5.8196599070876834E-002 2.3899889258154141E-002 0.18735818493191736 -4.5014945417968043E-002 -0.19474667893321534 0.37965825907059175 6.5455354963072102E-002 -4.9475720929659427E-002 1.4698085481358711E-002 -1.5754589207894999E-002
-4.9693424093706064E-002 -5.8934844135595896E-002 -0.40527736406335207 0.12091937543135527 0.31920600121750364 -9.3463809897781150E-002 0.35946950202708949 0.39479695122789171 0.26152559530673863 0.20368666757278484
0.55849522149121633 -0.22929945665672966 3.2307223736802955E-002 -7.7955574587493786E-003 -5.1880906899369417E-002 0.10116013092720660 2.7515429473168450E-002 -2.0893890292604012E-002 -2.8890715031042007E-002 3.1133417130443486E-002
2.7341869636190064E-002 4.3082559385382760E-002 -4.3630866946842393E-002 1.1409740259220983E-002 -2.5921128283858931E-002 3.1754371258996619E-003 -0.34122726994762859 -0.38398273493603591 0.66203021183173516 0.53371422665598345
-0.39765860215318832 0.16327156139584884 4.3817792031671157E-003 -1.0934099843367667E-003 -8.5075895561367076E-002 0.16589345900525515 -2.6271269600033648E-002 1.9943329518700818E-002 -1.5047871860352896E-002 1.6203031307867211E-002
2.4675838035114035E-002 2.4055453547147249E-002 0.29927723599462325 -7.6787419976604057E-002 -0.27283817557214618 9.1939982494132336E-002 0.44455671765183380 0.48560760388095869 0.31234106472555895 0.24311032947772529
2 113 122 : spinor index, minimum and maximum band indices
1.8236993529185390E-002 6.2112610630753559E-002 -8.8974876160086119E-002 -0.35308325622547782 0.38182470695450960 0.29409405903457875 0.24803355142331024 -0.31626316950941941 0.19748693332359835 -0.27229432913135038
-0.34529962636528311 0.14180453686986638 0.29779229669329332 -7.1543655141407314E-002 0.21710824664617956 -0.42326402657414108 -3.7519914482122573E-003 2.8623032738110208E-003 9.7169955505009553E-004 -1.0386991778912425E-003
6.0838592349577881E-003 4.2927089895910320E-002 1.3157574156115098E-002 5.1490708449078319E-002 2.5655697039523199E-002 2.3736411419166173E-002 -0.20156025833793376 0.23680826971534313 0.43747362317479532 -0.57411276517397636
0.45343534727362278 -0.18621849831080028 0.27101185595447475 -6.5117914045248998E-002 0.10131797498470552 -0.19752290071252609 -1.0084988699763904E-002 7.6421426501815885E-003 2.1830995352695296E-003 -2.3345851586931985E-003
-2.7684501649545550E-002 -0.10851239911094569 0.13516260968382901 0.47941092268535773 -0.41978880203840579 -0.33341077581720613 0.20267756592445874 -0.25460848140507081 0.16548991432469223 -0.22797175668733685
-2.8585260061257719E-002 1.1734322968554152E-002 2.4383986009534186E-003 -6.0856466432317093E-004 8.2492766853309571E-002 -0.16085981586449072 -0.42040403900367823 0.31921618061846457 -0.14266406029112158 0.15369369074527470
0.24224027554960439 0.37610688531154091 0.47545651651293136 -0.12300367302458076 0.28924718586638010 -0.11015796249289730 2.1999755039270798E-002 3.4727917061352101E-002 3.2008451617628046E-002 2.6634080830947995E-002
-4.5414780428451484E-002 1.8641479514255731E-002 -4.6232183064269869E-004 1.1410431838999753E-004 8.8806489583543209E-003 -1.7315821207509099E-002 0.32843554013251253 -0.24937107132790917 -0.30692122626908874 0.33065912636050526
-0.33334368259041536 -0.53104059936850068 0.41984833640129832 -0.16547752321328690 0.16135576038463453 -3.7880400477597616E-002 -3.3368538388726832E-002 -2.8540461741923859E-002 6.2001337307350239E-002 5.0596270988308392E-002
6.6336435455759346E-002 -2.7240671198532532E-002 -1.1775411876756554E-002 2.8602948288625040E-003 -9.9157298447054107E-002 0.19335376792255365 -0.34102943546560488 0.25894582250188714 -0.11948559164593041 0.12872329587322476
28 0.5000000000 0.5000000000 0.1250000000 : k-point index, k-point (lattice coordinates)
1 113 122 : spinor index, minimum and maximum band indices
-6.1515096626598646E-002 6.1612219006489777E-002 0.17170980679482983 -4.0051125110009689E-002 -0.29752982039845277 0.31223638063918985 -0.22098239576655315 0.57946503738838928 7.1887366702233389E-003 -6.0581821932904284E-003
0.56100327571308717 0.56002196520015590 0.12209828135314912 0.52344875227881549 0.19613182510463409 0.18687405992450715 7.9228121360813801E-003 3.0261300457193729E-003 -6.2314498452981246E-002 -7.3481021554261367E-002
3.3272619431786783E-002 -3.3340175977768054E-002 2.2057374609291115E-002 -5.1453456378953875E-003 1.9055042823763635E-002 -1.9995211285651526E-002 8.7250943021873976E-003 -2.2858214251131100E-002 0.47466512856794507 -0.40041503743938262
-0.41844793421386101 -0.41772343810391022 0.13501626166407557 0.57883525185958351 0.39181514251649685 0.37332134838922204 5.7419820604144897E-002 2.1893743665765852E-002 -1.3942702159839528E-002 -1.6434321541767768E-002
3.0486552814197841E-002 -3.0541830153133845E-002 -0.11747468130197847 2.7401014533992463E-002 0.25985252232065814 -0.27269514001335265 -0.27784972683990866 0.72858424095239671 7.8739073809755214E-003 -6.6349643528682651E-003
-5.8084470193386140E-002 5.8187403273692220E-002 0.44621267260486663 -0.10408188596767155 -0.28661139174211875 0.30084346404148682 -1.1960239792132307E-002 3.1334258276348601E-002 -8.9649014907070175E-003 7.6218738028973878E-003
3.0976561996732750E-005 2.9235047642197245E-005 9.8120881629619030E-006 9.0156805509387817E-006 -6.2803775289612001E-006 1.2853628925197095E-005 2.0379326412612742E-007 1.1461466949267621E-006 -2.0774127519524908E-004 7.3817769266421723E-005
3.1424888735787047E-002 -3.1480056807306873E-002 5.7320352725226120E-002 -1.3370505735133223E-002 1.8355166840632136E-002 -1.9268153300956679E-002 4.6513136479433583E-004 -1.2385257784396845E-003 -0.59193372016371171 0.50371549172494723
-1.9907117446939351E-005 -2.4324003111759077E-005 -6.9489186536820304E-007 1.2462722049148780E-005 -1.4084866010112387E-005 2.5669367667638689E-005 3.0590983816187534E-006 2.5997409259626909E-007 -4.3466969710263348E-005 1.3470925717930237E-005
2.8789288175695232E-002 -2.8840431582744335E-002 -0.30527188462700550 7.1206563673985049E-002 0.25031601022013211 -0.26274498769986504 -1.5037308655390927E-002 3.9396632556562075E-002 -9.8177545484433582E-003 8.3470038481185827E-003
2 113 122 : spinor index, minimum and maximum band indices
-4.2004593920481934E-002 -4.1930704290769685E-002 7.6296187221820355E-002 0.32709248454038325 -0.37868057488626888 -0.36080734367386735 0.72964862210311709 0.27825672196215917 -1.0672732200520049E-002 -1.2573417772610241E-002
0.30371054079910947 -0.30423334182440770 -0.20788239505651537 4.8485308878073931E-002 -0.26886430031196318 0.28215749647407473 -2.1860738133568397E-002 5.7334994011506421E-002 1.0281033454605057E-002 -8.6773190670805557E-003
-4.5853781809946655E-002 -4.5768183152233279E-002 -1.4325654305878625E-002 -6.1417562053316513E-002 -2.7766822449188228E-002 -2.6457927721683872E-002 -2.2893401730944927E-002 -8.7238527901816413E-003 -0.64347221297701940 -0.75874412068144714
-0.40716611898263616 0.40788113773289497 -0.18798944165260126 4.3856481084509673E-002 -0.13458529728011254 0.14123927652031856 -3.0203657229609607E-003 7.9110954012684385E-003 4.5970463699569863E-002 -3.8774082383344607E-002
8.4743119882683252E-002 8.4604396917215843E-002 -0.11152166529899110 -0.47810956637871255 0.43358926724754593 0.41312328305766088 0.58031141322633029 0.22130576155652620 -9.7452897337974229E-003 -1.1480640485178035E-002
-2.5688851489317655E-006 -8.9459194104993023E-007 -6.9733693497340520E-007 3.6854320688068372E-006 1.7069248444752654E-005 -2.3004646417783296E-005 4.4868258719157668E-005 3.8553702226465345E-006 -3.4640332794075060E-005 1.1004760898634864E-005
0.28679690321838747 -0.28730007105807864 -0.54021479257236527 0.12600732250850505 -0.25900176859297946 0.27186187585332899 -1.1834285999439674E-003 3.0997772458221263E-003 -1.2824850854489554E-002 1.0912219831140775E-002
-5.7167024127121232E-006 1.6046240945657347E-007 -7.4843358703179971E-007 -7.2663276989378263E-007 6.2979810619184640E-007 -2.0316293860799835E-006 -4.0323643094332723E-006 7.6077297811447109E-006 -2.1150936808651578E-003 7.3370114042800745E-004
-0.38450061742801411 0.38517068648844521 -0.48852706346410796 0.11395247464400909 -0.12964911511269606 0.13608526799057080 -1.6407462665771070E-004 4.2747135373174356E-004 -5.7325575687573481E-002 4.8781084511240975E-002
9.5251748255646749E-007 7.8298734490113239E-006 8.9988337907502977E-007 -7.2546897035902132E-006 -1.8570552882409871E-005 2.5602979171048828E-005 3.6484146654001285E-005 3.8854734895138205E-006 -3.1672655891732993E-005 1.1142099874869538E-005
29 0.5000000000 0.5000000000 0.2500000000 : k-point index, k-point (lattice coordinates)
1 113 122 : spinor index, minimum and maximum band indices
2.6769036871739366E-005 -4.9535262444590182E-006 0.37092452204723370 0.12639882493135646 0.24110193620108694 0.24460388913101661 0.16608294903318899 0.54730032976968990 -1.4034939772374083E-005 1.0930001499215591E-006
-0.69014859636342507 -0.71097956574017429 9.0098882443517825E-005 -1.4894645616747582E-004 -1.4216032080877072E-005 1.4274218334137112E-005 4.6814112031508259E-006 5.4775083804890073E-006 9.2206009768882012E-003 5.1743089433605352E-002
-1.9474549044605334E-002 3.0266725415995090E-002 1.4929950317297953E-005 2.8967363545026290E-006 -2.9195845718780716E-006 1.3378183369426163E-006 -1.3421461839130537E-005 -2.4480192450427284E-005 -0.63427605558901123 3.0552844569564641E-002
1.0842312537912013E-004 1.2020466277051778E-004 0.28499782360169124 -0.83627843332306040 -0.33058918397292847 0.32582110650164819 -6.0264650067515829E-002 1.8279786104925921E-002 3.5132498884858990E-006 7.4906155010656672E-007
-9.7976001228378048E-006 7.5625022888542961E-006 -0.22898090751457134 -7.8035977955603117E-002 -0.20533143448876828 -0.20830810774149261 0.20861889424996993 0.68747057812410151 -1.5711594534681299E-005 1.3786717942802781E-006
3.8648083466184607E-005 -3.4902293093967918E-005 -6.8982433763468118E-002 -2.3507616599144167E-002 0.40735651876567092 0.41332757172885165 7.0668700941062285E-002 0.23296275513950238 -7.0986884121494685E-006 -1.1532808505726357E-005
-6.4120024361707009E-002 8.0128878501330783E-002 -6.2661032515844392E-006 -2.8109775985299632E-006 3.8652582037543770E-007 9.9112156381846073E-007 8.6205162877787604E-007 3.0240954657431464E-006 5.8188567118239262E-002 -3.9020906428520963E-002
-5.9813768968684067E-002 5.2894455529100222E-002 -2.3706888089411113E-006 -1.1553613704500280E-006 -1.6382730494467548E-006 -2.6149071427616910E-006 -1.8605412483132708E-006 -1.1603521986196024E-005 -0.37547521579819931 -0.66940862904541842
-7.7562504000316945E-006 2.7233287495792569E-006 6.4513240919052612E-006 -2.4360196637826584E-005 1.0248851625622772E-005 1.7426718203102240E-006 -2.1566694273950873E-006 1.6266466631138867E-007 3.7791186198662952E-006 3.1448314423039581E-006
-2.0790546912401491E-005 1.8662931401167532E-005 4.2586057341702156E-002 1.4512419743420170E-002 -0.34691483966555781 -0.35199930777085037 8.8767197991049818E-002 0.29262605983415246 -8.9751913447910873E-006 -1.3616337443904136E-005
2 113 122 : spinor index, minimum and maximum band indices
2.0315823565888376E-005 2.2221159401849870E-005 7.9371386760988108E-002 -0.23290387099927382 0.40901969468558513 -0.40312705651224601 -0.74715851372283426 0.22671915626772221 3.9506302447915412E-006 1.2075194273939174E-005
-5.8580989814052686E-005 3.2811447349401224E-005 -0.82217936441953421 -0.28019199831636188 0.16595044856467495 0.16837194507074560 1.6818946492701874E-002 5.5449720577329872E-002 -1.7879691986549817E-006 2.9054584300481408E-006
6.0679625838757863E-002 6.2509172179838424E-002 -3.8982506294021390E-006 1.4110908448753645E-005 7.4913831994674465E-007 -3.1527059978729288E-006 2.6346670592180145E-005 -9.3393430102001959E-006 0.10490965907131683 0.58851707986747803
0.22154460755175759 -0.34421095382752759 -1.4884599768583140E-004 -8.1925583521019751E-005 8.3719010173927133E-006 5.7814470215550307E-006 5.7593712667457914E-006 -4.7443747808496861E-006 -5.5767362052300568E-002 2.6833305384012986E-003
-3.4294783285213567E-005 -4.4731811993317646E-005 -0.12856350721854093 0.37728234144535633 -0.48028350678706849 0.47336096655554782 -0.59481855013075258 0.18049230824597517 3.6090606526929541E-006 9.5158338569505340E-006
1.0354850318274335E-007 -6.7038039380938264E-007 9.1496478553171390E-007 -4.5061730816504775E-006 -2.1697866642799173E-005 -5.7059135086057465E-006 -2.1790419114903908E-005 3.6487395778732526E-005 1.5997415806831088E-005 -6.9521850745823267E-006
-1.1106162096852223E-004 9.8750074927878018E-005 0.15290351705781169 5.2106637920094859E-002 0.28039524853101661 0.28450473059223269 7.1593571399944551E-003 2.3601131123610737E-002 2.3761103986122412E-006 -3.7516508053156428E-006
5.6409533612357590E-003 -7.0477909475885336E-003 -1.0277870876457942E-007 -4.3011662977353827E-007 -1.0640171628618248E-006 -1.5286082450541400E-006 7.1860420168931794E-007 2.6466629684853761E-006 0.66184234685942644 -0.44377404257980341
0.68031660721465670 -0.60161052802426451 2.7070370424292500E-005 1.3354910134519976E-005 1.2741033758256748E-005 1.0848415333525319E-005 -2.3261354329708051E-007 -1.4072033348751234E-006 -3.3014824616144793E-002 -5.8852923173934292E-002
8.6364269664945832E-006 -6.5616494681544313E-006 -4.0913092091266991E-006 8.6724760294995755E-006 2.2195363311994289E-005 4.0226256061987531E-006 -1.8246459653525218E-005 2.9571228869928674E-005 1.4273821865600726E-005 -6.1757545031093207E-006

53
test/python/elk.in Normal file
View File

@ -0,0 +1,53 @@
! This example generates the spin-polarised Wannier projector outputs for Ba2YIrO6
! Wannier Ir-d states
! Example by Alyn D. N. James
tasks
0
805
spinorb
.true.
ngridk
8 8 8
rgkmax
7.0
!Path to Elk's species directory
sppath
'../../../../../species/'
avec
7.888832000 7.888832000 0.000000000
7.888832000 -7.888832000 0.000000000
7.888832000 0.000000000 7.888832000
atoms
4 : nspecies
'O.in' : spfname
6 : natoms; atposl, bfcmt below
0.26449000 0.26449000 0.47102000 0.00000000 0.00000000 0.00000000
0.73551000 0.73551000 0.52898000 0.00000000 0.00000000 0.00000000
0.73551000 0.73551000 0.00000000 0.00000000 0.00000000 0.00000000
0.26449000 0.26449000 0.00000000 0.00000000 0.00000000 0.00000000
0.73551000 0.26449000 0.00000000 0.00000000 0.00000000 0.00000000
0.26449000 0.73551000 0.00000000 0.00000000 0.00000000 0.00000000
'Ba.in' : spfname
2 : natoms; atposl, bfcmt below
0.75000000 0.25000000 0.50000000 0.00000000 0.00000000 0.00000000
0.25000000 0.75000000 0.50000000 0.00000000 0.00000000 0.00000000
'Ir.in' : spfname
1 : natoms; atposl, bfcmt below
0.50000000 0.50000000 0.00000000 0.00000000 0.00000000 0.00000000
'Y.in' : spfname
1 : natoms; atposl, bfcmt below
0.00000000 0.00000000 0.00000000 0.00000000 0.00000000 0.00000000
wanproj !projector flag
1 !number of projectors
3 2 5 !species, l, lm submatrix size
5 6 7 8 9 !the lm quanties which will be projected (vector length eq. rlmmax)
-0.045 0.1617 ![-1.22, 4] eV correlated energy window including the t2g+eg+Op.

View File

@ -0,0 +1,34 @@
################################################################################
#
# TRIQS: a Toolbox for Research in Interacting Quantum Systems
#
# Copyright (C) 2011 by M. Aichhorn, L. Pourovskii, V. Vildosola
#
# TRIQS is free software: you can redistribute it and/or modify it under the
# terms of the GNU General Public License as published by the Free Software
# Foundation, either version 3 of the License, or (at your option) any later
# version.
#
# TRIQS is distributed in the hope that it will be useful, but WITHOUT ANY
# WARRANTY; without even the implied warranty of MERCHANTABILITY or FITNESS
# FOR A PARTICULAR PURPOSE. See the GNU General Public License for more
# details.
#
# You should have received a copy of the GNU General Public License along with
# TRIQS. If not, see <http://www.gnu.org/licenses/>.
#
################################################################################
from h5 import *
from triqs.utility.comparison_tests import *
from triqs.utility.h5diff import h5diff
import triqs.utility.mpi as mpi
from triqs_dft_tools.converters import ElkConverter
Converter = ElkConverter(filename='Ba2YIrO6')
Converter.hdf_file = 'elk_convert.out.h5'
Converter.convert_dft_input()
if mpi.is_master_node():
h5diff('elk_convert.out.h5','elk_convert.ref.h5')

Binary file not shown.