@@ -58,7 +58,7 @@ def density_of_states(self, mu=None, broadening=None, mesh=None, with_Sigma=True
58
58
Calculates the density of states and the projected density of states.
59
59
The basis of the projected density of states is specified by proj_type.
60
60
61
- The output files (if `save_to_file = True`) have two (three in the orbital-resolved case) columns representing the frequency and real part of the DOS (and imaginary part of the DOS) in that order.
61
+ The output files (if `save_to_file = True`) have two (three in the orbital-resolved case) columns representing the frequency and real part of the DOS (and imaginary part of the DOS) in that order.
62
62
63
63
The output files are as follows:
64
64
@@ -75,12 +75,12 @@ def density_of_states(self, mu=None, broadening=None, mesh=None, with_Sigma=True
75
75
Lorentzian broadening of the spectra to avoid any numerical artifacts.
76
76
If not given, standard value of lattice_gf (0.001 eV) is used.
77
77
mesh : real frequency MeshType, optional
78
- Omega mesh for the real-frequency Green's function.
78
+ Omega mesh for the real-frequency Green's function.
79
79
Given as parameter to lattice_gf.
80
80
with_Sigma : boolean, optional
81
- If True, the self energy is used for the calculation.
81
+ If True, the self energy is used for the calculation.
82
82
If false, the DOS is calculated without self energy.
83
- Both with_Sigma and with_dc equal to True is needed for DFT+DMFT A(w) calculated.
83
+ Both with_Sigma and with_dc equal to True is needed for DFT+DMFT A(w) calculated.
84
84
Both with_Sigma and with_dc equal to false is needed for DFT A(w) calculated.
85
85
with_dc : boolean, optional
86
86
If True the double counting correction is used.
@@ -90,7 +90,7 @@ def density_of_states(self, mu=None, broadening=None, mesh=None, with_Sigma=True
90
90
By default, no projected DOS type will be calculated (the corresponding projected arrays will be empty).
91
91
The following options are:
92
92
93
- 'None' - Only total DOS calculated
93
+ 'None' - Only total DOS calculated
94
94
'wann' - Wannier DOS calculated from the Wannier projectors
95
95
'vasp' - Vasp orbital-projected DOS only from Vasp inputs
96
96
'wien2k' - Wien2k orbital-projected DOS from the wien2k theta projectors
@@ -108,11 +108,11 @@ def density_of_states(self, mu=None, broadening=None, mesh=None, with_Sigma=True
108
108
DOSproj : Dict of numpy arrays
109
109
DOS projected to atom (shell) with the form of DOSproj[n_shells][spn][n_om] where "n_shells" is the total number of correlated or uncorrelated shells (depending on the input "proj_type"). This array gives the trace of the orbital-projected density of states. Empty if proj_type = None
110
110
DOSproj_orb : Dict of numpy arrays
111
- Orbital-projected DOS projected to atom (shell) and resolved into orbital contributions with the form of DOSproj_orb[n_shells][spn][n_om,dim,dim] where "dim" specifies the orbital dimension of the correlated/uncorrelated shell (depending on the input "proj_type").
111
+ Orbital-projected DOS projected to atom (shell) and resolved into orbital contributions with the form of DOSproj_orb[n_shells][spn][n_om,dim,dim] where "dim" specifies the orbital dimension of the correlated/uncorrelated shell (depending on the input "proj_type").
112
112
Empty if proj_type = None
113
113
"""
114
114
115
- # Note the proj_type = 'elk' (- Elk orbital-projected DOS only from Elk inputs) is not included for now.
115
+ # Note the proj_type = 'elk' (- Elk orbital-projected DOS only from Elk inputs) is not included for now.
116
116
# Brief description to why can be found in the comment above the currently commented out dft_band_characters() routine
117
117
# in converters/elk.py.
118
118
# code left here just in case it will be reused.
@@ -284,7 +284,7 @@ def density_of_states(self, mu=None, broadening=None, mesh=None, with_Sigma=True
284
284
285
285
def proj_type_G_loc (self , G_latt , G_inp , ik , ish , proj_type = None ):
286
286
"""
287
- Internal routine which calculates the project Green's function subject to the
287
+ Internal routine which calculates the project Green's function subject to the
288
288
proj_type input.
289
289
290
290
Parameters
@@ -302,15 +302,15 @@ def proj_type_G_loc(self, G_latt, G_inp, ik, ish, proj_type=None):
302
302
'wann' - Wannier DOS calculated from the Wannier projectors
303
303
'vasp' - Vasp orbital-projected DOS only from Vasp inputs
304
304
'wien2k' - Wien2k orbital-projected DOS from the wien2k theta projectors
305
-
305
+
306
306
Returns
307
307
-------
308
308
G_proj : Gf
309
309
projected/downfolded lattice Green's function
310
310
Contains the band-resolved density matrices per k-point.
311
311
"""
312
312
313
- # Note the proj_type = 'elk' (- Elk orbital-projected DOS only from Elk inputs) is not included for now.
313
+ # Note the proj_type = 'elk' (- Elk orbital-projected DOS only from Elk inputs) is not included for now.
314
314
# Brief description to why can be found in the comment above the currently commented out dft_band_characters() routine
315
315
# in converters/elk.py.
316
316
# code left here just in case it will be reused.
@@ -338,7 +338,7 @@ def proj_type_G_loc(self, G_latt, G_inp, ik, ish, proj_type=None):
338
338
# isp=ntoi[bname]
339
339
# nst=self.n_orbitals[ik,isp]
340
340
# #matrix multiply band resolved muffin density with
341
- # #diagonal of band resolved spectral function and fill diagonal of
341
+ # #diagonal of band resolved spectral function and fill diagonal of
342
342
# #DOSproj_orb orbital dimensions with the result for each frequency
343
343
# bdm=self.band_dens_muffin[ik,isp,ish,0:dim,0:nst]
344
344
# tmp=[numpy.matmul(bdm, gf.data[iom,:,:].diagonal())
@@ -356,14 +356,14 @@ def proj_type_G_loc(self, G_latt, G_inp, ik, ish, proj_type=None):
356
356
357
357
def load_parproj (self , data_type = None ):
358
358
"""
359
- Internal routine which loads the n_parproj, proj_mat_all, rot_mat_all and
359
+ Internal routine which loads the n_parproj, proj_mat_all, rot_mat_all and
360
360
rot_mat_all_time_inv from parproj data from .h5 file.
361
361
362
362
Parameters
363
363
----------
364
364
data_type : string, optional
365
- which data type desired to be read in.
366
- 'band' - reads data converted by bands_convert()
365
+ which data type desired to be read in.
366
+ 'band' - reads data converted by bands_convert()
367
367
None - reads data converted by parproj_convert()
368
368
"""
369
369
@@ -390,15 +390,15 @@ def load_parproj(self, data_type=None):
390
390
391
391
def occupations (self , mu = None , with_Sigma = True , with_dc = True , save_occ = True ):
392
392
"""
393
- Calculates the band resolved density matrices (occupations) from the Matsubara
393
+ Calculates the band resolved density matrices (occupations) from the Matsubara
394
394
frequency self-energy.
395
395
396
396
Parameters
397
397
----------
398
398
mu : double, optional
399
399
Chemical potential, overrides the one stored in the hdf5 archive.
400
400
with_Sigma : boolean, optional
401
- If True, the self energy is used for the calculation.
401
+ If True, the self energy is used for the calculation.
402
402
If false, the DOS is calculated without self energy.
403
403
with_dc : boolean, optional
404
404
If True the double counting correction is used.
@@ -455,16 +455,16 @@ def occupations(self, mu=None, with_Sigma=True, with_dc=True, save_occ=True):
455
455
def spectral_contours (self , mu = None , broadening = None , mesh = None , plot_range = None , FS = True , with_Sigma = True , with_dc = True , proj_type = None , save_to_file = True ):
456
456
"""
457
457
Calculates the correlated spectral function at the Fermi level (relating to the Fermi
458
- surface) or at specific frequencies.
458
+ surface) or at specific frequencies.
459
459
460
460
The output files have three columns representing the k-point index, frequency and A(k,w) in that order. The output files are as follows:
461
461
462
462
* `Akw_(sp).dat`, the total A(k,w)
463
463
* `Akw_(proj_type)_(spn)_proj(i).dat`, the A(k,w) projected to shell with index (i).
464
464
* `Akw_(proj_type)_(spn)_proj(i)_(m)_(n).dat`, as above, but for each (m) and (n) orbital contribution.
465
-
466
- The files are prepended with either of the following:
467
- For `FS` set to True the output files name include _FS_ and these files contain four columns which are the cartesian reciprocal coordinates (kx, ky, kz) and Akw.
465
+
466
+ The files are prepended with either of the following:
467
+ For `FS` set to True the output files name include _FS_ and these files contain four columns which are the cartesian reciprocal coordinates (kx, ky, kz) and Akw.
468
468
For `FS` set to False the output files name include _omega_(iom) (with `iom` being the frequency mesh index). These files also contain four columns as described above along with a comment at the top of the file which gives the frequency value at which the spectral function was evaluated.
469
469
470
470
Parameters
@@ -476,7 +476,7 @@ def spectral_contours(self, mu=None, broadening=None, mesh=None, plot_range=None
476
476
Lorentzian broadening of the spectra to avoid any numerical artifacts.
477
477
If not given, standard value of lattice_gf (0.001 eV) is used.
478
478
mesh : real frequency MeshType, optional
479
- Omega mesh for the real-frequency Green's function.
479
+ Omega mesh for the real-frequency Green's function.
480
480
Given as parameter to lattice_gf.
481
481
plot_shift : double, optional
482
482
Offset [=(ik-1)*plot_shift, where ik is the index of the k-point] for each A(k,w) for stacked plotting of spectra.
@@ -485,12 +485,12 @@ def spectral_contours(self, mu=None, broadening=None, mesh=None, plot_range=None
485
485
If not provided, the min and max values of the energy mesh is used.
486
486
FS : boolean
487
487
Flag for calculating the spectral function at the Fermi level (omega ~ 0)
488
- If False, the spectral function will be generated for each frequency within
489
- plot_range.
488
+ If False, the spectral function will be generated for each frequency within
489
+ plot_range.
490
490
with_Sigma : boolean, optional
491
- If True, the self energy is used for the calculation.
491
+ If True, the self energy is used for the calculation.
492
492
If false, the DOS is calculated without self energy.
493
- Both with_Sigma and with_dc equal to True is needed for DFT+DMFT A(k,w) calculated.
493
+ Both with_Sigma and with_dc equal to True is needed for DFT+DMFT A(k,w) calculated.
494
494
Both with_Sigma and with_dc equal to false is needed for DFT A(k,w) calculated.
495
495
with_dc : boolean, optional
496
496
If True the double counting correction is used.
@@ -500,7 +500,7 @@ def spectral_contours(self, mu=None, broadening=None, mesh=None, plot_range=None
500
500
By default, no projected DOS type will be calculated (the corresponding projected arrays will be empty).
501
501
The following options are:
502
502
503
- * `None` Only total DOS calculated
503
+ * `None` Only total DOS calculated
504
504
* `wann` Wannier DOS calculated from the Wannier projectors
505
505
save_to_file : boolean, optional
506
506
If True, text files with the calculated data will be created.
@@ -652,7 +652,7 @@ def spaghettis(self, mu=None, broadening=None, mesh=None, plot_shift=0.0, plot_r
652
652
Chemical potential, overrides the one stored in the hdf5 archive.
653
653
By default, this is automatically set to the chemical potential within the SK object.
654
654
broadening : double, optional
655
- Lorentzian broadening of the spectra to avoid any numerical artifacts.
655
+ Lorentzian broadening of the spectra to avoid any numerical artifacts.
656
656
If not given, standard value of lattice_gf (0.001 eV) is used.
657
657
mesh : real frequency MeshType, optional
658
658
Omega mesh for the real-frequency Green's function.
@@ -669,9 +669,9 @@ def spaghettis(self, mu=None, broadening=None, mesh=None, plot_shift=0.0, plot_r
669
669
function is calculated for all shells.
670
670
Note for experts: The spectra from Wien2k inputs are not rotated to the local coordinate system used in Wien2k.
671
671
with_Sigma : boolean, optional
672
- If True, the self energy is used for the calculation.
672
+ If True, the self energy is used for the calculation.
673
673
If false, the DOS is calculated without self energy.
674
- Both with_Sigma and with_dc equal to True is needed for DFT+DMFT A(k,w) calculated.
674
+ Both with_Sigma and with_dc equal to True is needed for DFT+DMFT A(k,w) calculated.
675
675
Both with_Sigma and with_dc equal to false is needed for DFT A(k,w) calculated.
676
676
with_dc : boolean, optional
677
677
If True the double counting correction is used.
@@ -681,12 +681,12 @@ def spaghettis(self, mu=None, broadening=None, mesh=None, plot_shift=0.0, plot_r
681
681
By default, no projected DOS type will be calculated (the corresponding projected arrays will be empty).
682
682
The following options are:
683
683
684
- 'None' - Only total DOS calculated
684
+ 'None' - Only total DOS calculated
685
685
'wann' - Wannier DOS calculated from the Wannier projectors
686
686
'wien2k' - Wien2k orbital-projected DOS from the wien2k theta projectors
687
687
save_to_file : boolean, optional
688
688
If True, text files with the calculated data will be created.
689
-
689
+
690
690
Returns
691
691
-------
692
692
Akw : Dict of numpy arrays
@@ -698,7 +698,7 @@ def spaghettis(self, mu=None, broadening=None, mesh=None, plot_shift=0.0, plot_r
698
698
Empty if proj_type = None
699
699
pAkw_orb : Dict of numpy arrays
700
700
(Correlated) k-resolved spectral function projected to atoms and
701
- resolved into orbital contributions.
701
+ resolved into orbital contributions.
702
702
This dictionary has the form of pAkw[n_shells][spn][n_k, n_om,dim,dim] where dim specifies the orbital dimension of the correlated/uncorrelated shell.
703
703
Empty if proj_type = None
704
704
"""
@@ -941,7 +941,7 @@ def gen_Akw(self, mu, broadening, mesh, plot_shift, plot_range, shell_list, with
941
941
mpi .barrier ()
942
942
943
943
return Akw , pAkw , pAkw_orb
944
-
944
+
945
945
def partial_charges (self , mu = None , with_Sigma = True , with_dc = True ):
946
946
"""
947
947
Calculates the orbitally-resolved density matrix for all the orbitals considered in the input, consistent with
0 commit comments