ACFDT/RPA calculations: Difference between revisions

From VASP Wiki
No edit summary
No edit summary
 
(68 intermediate revisions by 5 users not shown)
Line 1: Line 1:
__TOC__
The adiabatic-connection-fluctuation-dissipation theorem (ACFDT) can be used to derive the random-phase approximation (RPA).
 
The ACFDT-RPA ground-state energy <math>E_{\mathrm{RPA}}</math> is the sum of the ACFDT-RPA correlation energy <math>E_{c}</math> and the Hartree-Fock (HF) energy <math>E_{\mathrm{EXX}}</math> evaluated non self-consistently using Kohn-Sham orbitals computed within density-functional theory (DFT):
The ACFDT-RPA groundstate energy (<math>E_{\mathrm{RPA}}</math>) is the sum of the ACFDT-RPA correlation energy <math>E_{c}</math> and the Hartree-Fock energy evaluated non self-consistently using DFT orbitals <math>E_{\mathrm{EXX}}</math>:


<math>E_{\mathrm{RPA}}=E_{\mathrm{c}}+E_{\mathrm{EXX}}</math>.
<math>E_{\mathrm{RPA}}=E_{\mathrm{c}}+E_{\mathrm{EXX}}</math>.


Note that, <math>E_{\mathrm{EXX}}</math> here includes also the Hartree energy, the kinetic energy, as well as the Ewald energy of the ions, whereas often in literature <math>E_{\mathrm{EXX}}</math> refers only to the exact exchange energy evaluated using DFT orbitals.
Note that, here <math>E_{\mathrm{EXX}}</math> includes also the Hartree energy, the kinetic energy, as well as the Ewald energy of the ions, whereas often in literature <math>E_{\mathrm{EXX}}</math> refers only to the exact-exchange (EXX) energy evaluated using DFT orbitals.


If {{TAG|ALGO}}=''RPA'' is set in the {{TAG|INCAR}} file, VASP  calculates the correlation energy in the random phase approximation. To this end, VASP calculates first the independent particle response function, using the virtual (unoccupied) states found in the {{TAG|WAVECAR}} file, and then determines the correlation energy using the plasmon fluctuation equation:
If {{TAG|ALGO}}=RPA is set in the {{TAG|INCAR}} file, VASP  calculates the correlation energy within RPA. To this end, VASP first calculates the independent-particle response function, using the unoccupied states given in the {{TAG|WAVECAR}} file, and then determines the correlation energy using the plasmon-fluctuation equation:


<math>E_{c} = \frac{1}{2 \pi} \int_{0}^{\infty}  \mathrm{Tr} \, \ln(1-\chi( i \omega) V) + \chi( i \omega) V \, d \omega</math>.
<math>E_{c} = \frac{1}{2 \pi} \int_{0}^{\infty}  \mathrm{Tr} \, \ln(1-\chi( i \omega) V) + \chi( i \omega) V \, d \omega</math>.
Line 13: Line 12:
More information about the theory behind the RPA is found [[RPA/ACFDT: Correlation energy in the Random Phase Approximation|here]].  
More information about the theory behind the RPA is found [[RPA/ACFDT: Correlation energy in the Random Phase Approximation|here]].  


== General Recipe to Calculate ACFDT-RPA Total Energies ==
== General recipe to calculate ACFDT-RPA total energies ==


As of VASP.6 an RPA energy calculation can be done in one single step using a similar {{TAGBL|INCAR}} file as follows
The ACFDT-RPA total energies can be computed in a four-step procedure or in an all-in-one approach. The all-in-one approach is available as of VASP.6 and can be done in one single step.
Both procedures comprise a self-consistent DFT calculation, diagonalizing the KS Hamiltonian, and the RPA calculation itself. While the all-in-one approach is very convenient, there are several caveats discussed below.


  {{TAGBL|ALGO}} = RPAR # or ACFDTR
=== Four-step procedure to calculate ACFDT-RPA total energy ===


Here it is "important not to set {{TAGBL|NBANDS}}", otherwise VASP proceeds with the {{TAGBL|WAVECAR}} found in the directory (if not present a random wavefunction is used!).  
This four-step procedure is the standard procedure in VASP.5, and is also available in VASP.6 by setting {{TAG|NBANDS}} in the RPA step.  


Older versions of VASP can not perform all required steps of an RPA calculation in a single run and four individual steps have to be done in practice:
'''Step 1:''' a standard DFT run.
:All occupied orbitals (and as usual in VASP, a few unoccupied orbitals) of the DFT Hamiltonian are calculated. For instance,
{{TAG|EDIFF}} = 1E-8 # required for convergence of RPA total energies
{{TAG|ISMEAR}} = 0 ; {{TAG|SIGMA}} = 0.05
{{NB|warning| The convergence of DFT eigenenergies influences the convergence of the RPA correlation energy.|:}}
{{NB|tip|Use the Perdew-Burke-Ernzerhof (PBE) pseudopotentials with a small {{TAG|EDIFF}} and avoid {{TAG|ISMEAR}}>0.|:}}
:The DFT run can be done with your favorite setup, but we recommend attaining very high precision (small {{TAG|EDIFF}} tag) and to use a small smearing width ({{TAG|SIGMA}} tag), and to avoid higher-order Methfessel-Paxton smearing (see also {{TAG|ISMEAR}}). That is because Methfessel-Paxton smearing can lead to negative one-electron occupancies, which can result in unphysical correlation energies. We suggest using [[GGA|PBE]] orbitals as input for the ACFDT-RPA run, but other choices, e.g., local-density-approximation (LDA) or [[:Category:Hybrid_functionals|hybrids]], are possible as well. For hybrid functionals, we suggest carefully considering the caveats mentioned in Ref. {{cite|paier:2008}}. Specifically, the RPA dielectric matrix yields too weak screening for hybrid functionals, which potentially deteriorates RPA results.
'''Step 2:''' Compute the HF energy <math>E_{\mathrm{EXX}}</math> using the DFT orbitals. That is, e.g.,
{{TAG|ALGO}}  = EIGENVAL ; {{TAG|NELM}} = 1
{{TAG|LWAVE}} = .FALSE.                ! {{FILE|WAVECAR}} not written   
{{TAG|LHFCALC}} = .TRUE. ; {{TAG|AEXX}} = 1.0  ! {{TAG|ALDAC}} = 0.0
{{TAG|ISMEAR}} = 0 ; {{TAG|SIGMA}} = 0.05
:Here, {{TAG|LWAVE}} {{=}} .FALSE. avoids an accidental update of the {{FILE|WAVECAR}} file. Also, VASP automatically sets {{TAG|ALDAC}} {{=}} 1-{{TAG|AEXX}}, i.e., for {{TAG|AEXX}} {{=}} 1.0, {{TAG|ALDAC}} {{=}} 0.0.
{{NB|tip| For insulators and semiconductors with a sizable gap, faster k-point convergence of the HF energy can be obtained by setting {{TAG|HFRCUT}}{{=}}-1, although this slows convergence for metals.|:}}
'''Step 3:''' Compute a sufficient number of unoccupied states. 
:In the {{TAG|OUTCAR}} file of Step 1, search for <code>maximum number of plane-waves:</code> and run VASP again with the following {{TAG|INCAR}} file to determine the unoccupied states by exact diagonalization of the KS Hamiltonian. The KS Hamiltonian must be the same as in step 1, which might be DFT or hybrid.
{{TAG|NBANDS}} = maximum number of plane-waves (times 2 for vasp_gam)
{{TAG|ALGO}} = Exact    ! exact diagonalization
{{TAG|EDIFF}} = 1E-8 # required for convergence of RPA total energies
{{TAG|LOPTICS}} = .TRUE.
{{TAG|ISMEAR}} = 0 ; {{TAG|SIGMA}} = 0.05
:For calculations using <code>vasp_gam</code>, that is the gamma-point only version of VASP, {{TAG|NBANDS}} must be set to twice the <code>maximum number of plane-waves:</code> found in the {{TAG|OUTCAR}} file of Step 1. For metals, we recommend to avoid setting {{TAG|LOPTICS}}=.TRUE., since this slows down k-point convergence {{cite|p:2010}}. 
'''Step 4:''' Calculate the ACFDT-RPA correlation energy.
{{TAG|NBANDS}} =  maximum number of plane-waves
{{TAG|ALGO}} = ACFDT
{{TAG|NOMEGA}} = 12    ! default
{{TAG|ISMEAR}} = 0 ; {{TAG|SIGMA}} = 0.05
:The number of imaginary-frequency and imaginary-time-grid points {{TAG|NOMEGA}} is usually set to 8-24. For large gap insulators {{TAG|NOMEGA}} = 8 will suffice, while for semiconductors 10-12 suffices.
{{NB|important| For VASP 6.X, {{TAG|NBANDS}} must be set in this step.|:}}


*First step (a standard DFT run): All occupied orbitals (and as usual in VASP, a few unoccupied orbitals) of the DFT-Hamiltonian are calculated:
=== All-in-one approach to calculate ACFDT-RPA total energy ===
EDIFF = 1E-8
ISMEAR = 0 ; SIGMA = 0.05
This can be done with your favorite setup, but we recommend to attain very high precision (small {{TAG|EDIFF}} flag) and to use a small smearing width  ({{TAG|SIGMA}} flag), and to avoid higher order Methfessel-Paxton smearing (see also {{TAG|ISMEAR}}). We suggest to use PBE orbitals as input for the ACFDT-RPA run, but other choices are possible as well, e.g. LDA or hybrid functionals such as HSE. For hybrid functionals, we suggest to carefully consider the caveats mentioned in reference {{cite|paier:2008}}, specifically the RPA dielectric matrix yields significantly weak screening for hybrid functionals, which deteriorates RPA results.


VASP will read the {{FILE|WAVECAR}} file, perform a self-consistent DFT calculation by iterating until convergence is reached, diagonalize the DFT Hamiltonian in the basis set spanned by all KS orbitals, and finally proceed with the RPA calculation. The all-in-one approach is only available as of VASP.6, and it is particularly convenient for the RPAR and GWR algorithms. An example {{FILE|INCAR}} file is


*Second step: the Hartree Fock energy <math>E_{\mathrm{EXX}}</math> is calculated using the predetermined DFT orbitals:
{{TAG|ALGO}} = RPAR
  ALGO = EIGENVAL ; NELM = 1
   
  LWAVE=.FALSE.                 ! avoid accidental update of WAVECAR
  {{TAG|EDIFF}} = 1E-8  # required for convergence of RPA total energies
  LHFCALC = .TRUE. ; AEXX = 1.0  ! you my set ALDAC = 0.0 but the default is 1-AEXX
  {{TAG|ISMEAR}} = 0 ; {{TAG|SIGMA}} = 0.05
ISMEAR = 0 ; SIGMA = 0.05
 
For insulators and semiconductors with a sizable gap, faster convergence of the Hartree-Fock energy can be obtained by setting {{TAG|HFRCUT}}=-1, altough this slows down k-point convergence for metals.
{{TAG|NOMEGA}} = 8-24    ! for large gap insulators {{TAG|NOMEGA}} = 8 will suffice, for semiconductors 10-12 suffices
   
  {{TAG|LOPTICS}} = .TRUE. ! optional
  {{TAG|LPEAD}} = .TRUE.   ! required for 6.1 and 6.2 if {{TAG|LOPTICS}} = .TRUE.
{{NB|warning|The tag {{TAG|NBANDS}} must not be set in the {{FILE|INCAR}} file.|:}}
{{NB|warning|The convergence of DFT eigenenergies influences the convergence of the RPA correlation energy.|:}}
{{NB|tip|Use the Perdew-Burke-Ernzerhof (PBE) pseudopotentials with a small {{TAG|EDIFF}} and avoid {{TAG|ISMEAR}}>0.|:}}
The head of the dielectric function can be calculated only for insulators by setting the {{TAG|LOPTICS}} tag and only the Perturbation-Expression-After-Discretization (PEAD) method is supported, see {{TAG|LPEAD}}. Furthermore, {{TAG|EDIFF}} should be small to calculate the DFT orbitals with high precision. Although it is not strictly required, we recommend starting the calculation from a well-converged DFT {{TAG|WAVECAR}} file.


There are several caveats to the all-in-one approach:


*Third step: Search for ''maximum number of plane-waves:'' in the {{TAG|OUTCAR}} file of the first step, and run VASP again with the following {{TAG|INCAR}} file to determine all virtual states by an exact diagonalization of the Hamiltonian (DFT or hybrid, make certain to use the same  Hamiltonian as in step 1):
* There is no general support for ACFDT/RPA on top of hybrid functionals. In VASP <math>\leq</math> 6.2, only LDA and gradient corrected functionals are supported. As of VASP 6.2, the all-in-one approach can be used for Hartree-Fock-type calculations, as well as hybrid functionals without range separation. However, range-separated hybrid functionals (including HSE, {{TAG|LMODELHF}}) yield erroneous results or potentially even crash. Please compare the total energies in a standard DFT/hybrid functional calculation against the energies obtained for the mean-field step in the all-in-one approach: The energies must be exactly the same. If they differ, fall back to the four-step procedure that is explained above.
NBANDS = maximum number of plane-waves (times 2 for gamma-only calculations)
* To select the new all-in-one approach, it is important "''not to set'' {{TAG|NBANDS}}" in the RPA step. If {{TAG|NBANDS}} is set in the {{FILE|INCAR}} file, VASP.6 proceeds with reading the {{TAG|WAVECAR}} file found in the directory (if not present, random orbitals are used!), and then calculates the correlation energy using these orbitals and one-electron energies.
ALGO = Exact    ! exact diagonalization
* The basis set used in the diagonalization is strictly given by all plane waves. That is, there is no option to reduce the basis set size as one can by setting {{TAG|NBANDS}} in Step 3 and Step 4 of the four-step procedure.
NELM = 1        ! one step suffices since WAVECAR is pre-converged
* The exchange energy is only calculated if the low-scaling RPA is selected.
LOPTICS = .TRUE.
* As of VASP 6.3, the head of the dielectric function (G=0 component) can be calculated by setting {{TAG|LOPTICS}} = .TRUE.  
ISMEAR = 0 ; SIGMA = 0.05
* In the all-in-one procedure, VASP automatically sets {{TAG|LMAXFOCKAE}} and {{TAG|NMAXFOCKAE}}. This changes the energies for hybrid functionals and Hartree-Fock slightly. Hence, you need to set {{TAG|LMAXFOCKAE}} {{=}} 4 also in Step 1 of the four-step procedure to obtain the same results as in the all-in-one procedure.
For calculations using the gamma-point only version of vasp, {{TAG|NBANDS}} must be set to twice the ''maximum number of plane-waves:'' (found in the {{TAG|OUTCAR}} file) in step 1. For metals, we recommend to avoid setting {{TAG|LOPTICS}}=''.TRUE.'', since this slows down k-point convergence.{{cite|p:2010}}


=== Output of ACFDT-RPA total energy ===
The ACFDT-RPA total energy is calculated for 8 different energy cutoffs and a linear regression is used to extrapolate the results to the infinite cutoff limit, see [[ACFDT/RPA calculations#basis_cutoff|section below]]. A successful RPA calculation writes the following lines into the {{FILE|OUTCAR}} file:


*Fourth step: Calculate the ACFDT-RPA correlation energy:
      cutoff energy    smooth cutoff  RPA   correlation   Hartree contr. to MP2
  NBANDS =  maximum number of plane-waves
  ---------------------------------------------------------------------------------
ALGO = ACFDT
            316.767          316.767      -17.5265976349      -26.2640927215
NOMEGA = 8-24  
            301.683          301.683      -17.3846505665      -26.0990489039
            287.317          287.317      -17.2429031341      -25.9344769084
            273.635          273.635      -17.0686574017      -25.7325162480
            260.605          260.605      -16.8914915810      -25.5277026697
            248.195          248.195      -16.7202601717      -25.3302982602
            236.376          236.376      -16.5559849344      -25.1415392478
            225.120          225.120      -16.3635400223      -24.9210737434
  linear regression   
  converged value                          -19.2585393615      -28.2627347266
 
Here, the third and fourth columns correspond to the correlation energy (for that specific energy cutoff) in the RPA and the direct second-order Møller–Plesset (MP2) approximation, i.e., the second-order term in RPA. The corresponding results of the linear regression are found in the line starting with <code>converged value</code>.
<span id="ACFDTR/RPAR">
<span id="ACFDTR/RPAR">


== Low scaling ACFDT/RPA algorithm ==
== Low-scaling ACFDT/RPA algorithm ==
Virtually the same flags and procedures apply to the new low scaling RPA algorithm implemented in vasp.6.{{cite|kaltak:prb:2014}} However, {{TAG|ALGO}}=''ACFDT'' or {{TAG|ALGO}}=''RPA'' needs to be replaced by either {{TAG|ALGO}}=''ACFDTR'' or {{TAG|ALGO}}=''RPAR''.  
Virtually the same tags and procedures apply to the low-scaling RPA algorithm implemented in VASP 6 {{cite|kaltak:prb:2014}}. However, {{TAG|ALGO}}=ACFDT or {{TAG|ALGO}}=RPA needs to be replaced by either {{TAG|ALGO}}=ACFDTR or {{TAG|ALGO}}=RPAR.  


With this setting VASP calculates the independent particle polarizability <math> \chi(i\omega) </math> using Green's functions <math>G(i\tau)</math> on the imaginary time axis <math>i\tau</math> by the contraction formula{{cite|rojas:prl:1995}}
With this setting VASP calculates the independent-particle polarizability <math> \chi(i\omega) </math> using Green's functions <math>G(i\tau)</math> on the imaginary time axis <math>i\tau</math> by the contraction formula {{cite|rojas:prl:1995}}


<math>
<math>
Line 62: Line 106:
</math>
</math>


Subsequently a compressed Fourier transformation on the imaginary axes <math>\tau_m,\omega_n</math> yields  
Subsequently, a compressed Fourier transformation on the imaginary axes <math>\tau_m,\omega_n</math> yields  


<math>
<math>
Line 70: Line 114:
The remaining step is the evaluation of the correlation energy and is the same as described above.  
The remaining step is the evaluation of the correlation energy and is the same as described above.  


Crucial to this approach is the accuracy of the Fourier transformation from <math>\chi(i\tau)\to \chi(i\omega)</math>, which in general depends on two factors.
Crucial to this approach is the accuracy of the Fourier transformation from <math>\chi(i\tau)\to \chi(i\omega)</math>, which in general depends on two factors: First, the grid order <math>N</math> that can be set by {{TAG|NOMEGA}} in the {{TAG|INCAR}} file. Here, similar choices as for the {{TAG|ALGO}}{{=}}ACFDT are recommended. Second, the grid points <math>\tau_m,\omega_n</math> and Fourier matrix <math>\gamma_{nm}</math> have to be optimized for the same interval as spanned by all possible transition energies in the polarizability. The minimum (maximum) transition energy can be set with the {{TAG|OMEGAMIN}} ({{TAG|OMEGATL}}) tag and should be smaller (larger) than the bandgap, i.e., the maximum transition energy, of the previous DFT calculation. VASP determines these values automatically and writes it in the {{TAG|OUTCAR}} after the lines  
 
First, the grid order <math>N</math> that can be set by {{TAG|NOMEGA}} in the {{TAG|INCAR}} file. Here, similar choices as for the ''ACFDT'' algorithms are recommended.
Second, the grid points <math>\tau_m,\omega_n</math> and Fouier matrix <math>\gamma_{nm}</math> have to be optimized for the same interval as spanned by all possible transition energies in the polarizability. The minimum (maximum) transition energy can be set with the {{TAG|OMEGAMIN}} ({{TAG|OMEGATL}}) tag and should be smaller (larger) than the band gap (maximum transition energy) of the previous DFT calculation. VASP determines these values automatically and writes it in the {{TAG|OUTCAR}} after the lines  


  Response functions by GG contraction:  
  Response functions by GG contraction:  
These values should be checked for consistency. Furthermore we recommend to inspect the grid and transformation errors by looking for following lines in the {{TAG|OUTCAR}} file
These values should be checked for consistency. Furthermore, we recommend inspecting the grid and transformation errors by looking for the following lines in the {{TAG|OUTCAR}} file


  nu_ 1=  0.1561030E+00 ERR=  0.6327933E-05 finished after  1 steps     
  nu_ 1=  0.1561030E+00 ERR=  0.6327933E-05 finished after  1 steps     
Line 82: Line 123:
  Maximum error of frequency grid:  0.3369591E-06
  Maximum error of frequency grid:  0.3369591E-06


Every frequency point will have a similar line as shown above for the first point. The value after ''ERR='' corresponds to the maximum Fourier transformation error and should be of similar order as the maximum integration error of the frequency grid.
Every frequency point will have a similar line as shown above for the first point. The value after <code>ERR=</code> corresponds to the maximum Fourier-transformation error and should be of similar order as the maximum integration error of the frequency grid.
=== Output of low-scaling ACFDT/RPA ===
Selecting the low-scaling RPA algorithm, VASP computes the total energy in the RPA and writes the following output
  -----------------------------------------------------
  HF-free energy      FHF    =      -25.11173505 eV
  HF+RPA corr. energy TOTEN  =      -36.96463791 eV
  HF+E_corr(extrapolated)    =      -37.70506951 eV
The line <code>HF+RPA corr. energy TOTEN</code> contains the total energy calculated with the largest cutoff {{TAG|ENCUTGW}}.
The line <code>HF+E_corr(extrapolated)</code> contains the total energy with the extrapolated value for the RPA correlation energy.
=== Singles contribution to the correlation energy ===
The low-scaling RPA algorithm also allows for the determination of the so-called singles contribution,{{cite|klimes:jcp:143}}{{cite|ren:prb:88}} to the total energy represented by following diagrams:
 
[[File:SinglesDiagrams.png|320px]]
 
In most textbooks{{cite|mattuck:2012}} this contribution is assumed to be zero. Ren et al.{{cite|ren:prb:88}} pointed out that this is true only in the Hartree-Fock basis set. The singles contribution is non-vanishing for other basis sets.
 
The singles contribution is calculated for {{TAG|LSINGLES}}=.TRUE.. In this case following additional lines can be found in OUTCAR:
 
HF single shot energy change        -1.23182672
renormalized HF singles            -1.23310555
 
Here, the first line contains the value of the singles as proposed by Klimeš et al.,{{cite|klimes:jcp:143}} while the second line contains the singles contribution of Ren et al.{{cite|ren:prb:88}}. In most cases we found that the two values are exceedingly close to each other, which can be understood in the way how the propagator is renormalized.{{cite|klimes:jcp:143}}
<span id="RPAFORCES">
=== Optional: RPA Forces ===
Optionally, RPA forces can be calculated by adding following line to the {{FILE|INCAR}} file:
  {{TAG|LRPAFORCE}} = .TRUE.
For RPA forces the change in the one-electron density is required.{{cite|ramberger:prl:118}}
This is automatically performed with the linear-response routine within VASP.
After a successful run, the following block of data is found in the {{FILE|OUTCAR}} file.
 
POSITION                                      TOTAL RPA FORCE (eV/Angst)
-----------------------------------------------------------------------------------
      0.17542    -0.22348      0.17542        -0.292069      7.581315    -0.292069
      1.12850      1.31044      1.12850        0.304683    -7.605527      0.304683
-----------------------------------------------------------------------------------
    total drift:                                0.012614    -0.024212      0.012614
SUGGESTED UPDATED POSCAR (direct coordinates)  step
-----------------------------------------------------------------------------------
  -0.00958461  -0.00958461  0.13485779        0.04179056  0.04179056  0.00283088
  0.25787833  0.25787833  0.22191754        -0.04337198  -0.04337198  0.00431513
{{NB|warning|The RPA forces computed for metallic systems are currently not supported.}}
 
The suggested updated positions are also written to the CONTCAR file (if {{TAG|NSW}}=0). The updated positions are obtained by multiplying the RPA-forces with the parameter {{TAG|DAMP_NEWTON}} and the inverse of the DFT-Hessian (which is also calculated during the RPA force calculations) and adding the resultant vector to the current positions. {{TAG|DAMP_NEWTON}} currently defaults to 0.8, but the user might want to change this to 1.0 (no damping), or smaller values if instabilities are observed. The CONTCAR file can be copied to the POSCAR file, and a few such RPA calculations should recover the groundstate structure. Alternatively, standard relaxations ({{TAG|IBRION}} =1-4) or even MD's can be performed. 
</span>
=== Memory bottleneck and Parallelization ===
 
The cubic scaling space-time RPA algorithm requires considerably more memory than the corresponding quartic-scaling implementations, two Green's functions <math>G({\bf r,r'},i\tau_n)</math> have to be stored in real-space. To reduce the memory overhead, VASP exploits Fast Fourier Transformations (FFT) to avoid storage of the matrices on the (larger) real space grid, on the one hand. The precision of the FFT can be selected with {{TAG|PRECFOCK}}, where usually the values ''Fast'' sufficient.
 
On the other hand, the code avoids storage of redundant information, i.e., both the Green's function and polarizability matrices are distributed as well as the individual imaginary grid points. The distribution of the imaginary grid points can be set by hand with the {{TAG|NTAUPAR}} and {{TAG|NOMEGAPAR}} tags, which splits the imaginary grid points {{TAG|NOMEGA}} into {{TAG|NTAUPAR}} time and {{TAG|NOMEGAPAR}} groups. For this purpose both tags have to be divisors of {{TAG|NOMEGA}}.  


=== Note on Parallelization ===
The default values are usually reasonable choices provided the tag {{TAG|MAXMEM}} is set correctly and we strongly recommend to set {{TAG|MAXMEM}} instead of {{TAG|NTAUPAR}}.
{{NB|important|As of version 6.2, {{TAGBL|MAXMEM}} is estimated automatically (if not set) from the "MemAvailable" entry of the Linux kernel in "/proc/meminfo".}}


The low scaling RPA algorithm requires significantly more memory than the conventional method described in the previous section, because two Green's functions <math> G(i\tau)</math> and one polarizability <math> \chi(i\omega_n)</math> on {{TAG|NOMEGA}} imaginary grid points have to be stored.  
The required storage for a low-scaling RPA or GW calculation depends mostly on {{TAG|NTAUPAR}}, the number of MPI groups that share same imaginary time points. A rough estimate for the required bytes is given by


To reduce the memory overhead, VASP exploits Fast Fourier Transformations (FFT) to avoid storage of the matrices on the (larger) real space grid, on the one hand. The precision of the FFT can be selected with {{TAG|PRECFOCK}}, where usually the values ''Fast'' sufficient.
(NGX*NGY*NGZ)*(NGX_S*NGY_S*NGZ_S) / ( NCPU  / {{TAGBL|NTAUPAR}} ) * 16


On the other hand, the code avoids storage of redundant information,i.e. both the Green's function and polarizability matrices are distributed as well as the individual imaginary grid points. The distribution of the imaginary grid points can be set by hand with the {{TAG|NTAUPAR}} and {{TAG|NOMEGAPAR}} tags, which splits the imaginary grid points {{TAG|NOMEGA}} into {{TAG|NTAUPAR}} time and {{TAG|NOMEGAPAR}} groups. For this purpose both tags have to be divisors of {{TAG|NOMEGA}}.
where "NCPU" is the number of MPI ranks used for the job,"NGX,NGY,NGZ" denotes the number of FFT grid points for the exact exchange and "NGX_S,NGY_S,NGZ_S" the number of FFT grid points for the supercell. Note, both grids are written to the {{TAGBL|OUTCAR}} file after the lines


The default values are usually reasonable choices for moderately large unit cells. For small systems or on large memory architectures {{TAG|NTAUPAR}} should be increased to {{TAG|NOMEGAPAR}} with the latter chosen as close as possible to {{TAG|NOMEGA}}. For very large unit cells on the other hand we recommend to set {{TAG|NTAUPAR}}={{TAG|NOMEGAPAR}}=1 or use more CPUs if possible.
FFT grid for exact exchange (Hartree Fock)
FFT grid for supercell:


=== Storage requirements ===
The smaller {{TAG|NTAUPAR}} is set, the less memory per node the job requires to finish successfully.  
The cubic scaling space-time RPA algorithm requires considerably more memory than the quartic-scaling RPA implementation, because the complete polarizability <math>\chi_{\bf GG'}(q,i\omega_n)</math> is stored. More precisely the required storage for <math>N^3</math>-scaling RPA algorithm can be estimated by


<math>
The approximate memory requirement is calculated in advance and printed to screen and {{TAGBL|OUTCAR}} as follows:
16\times(</math>{{TAGBL|NOMEGA}}<math> +</math>{{TAGBL|NTAUPAR}}<math> )\times N_{\bf q}N_{\bf G}^2\quad {\rm bytes}
</math>


Here <math>N_{\bf q}</math> is the number of q-points and <math>N_{\bf G}</math> the number of plane waves used for the calculation.
min. memory requirement per mpi rank 1234 MB, per node 9872 MB
</span>
</span>


== Some Issues Particular to ACFDT-RPA Calculations on Metals ==
== Some Issues Particular to ACFDT-RPA Calculations on Metals ==


For metals, the RPA groundstate energy converges the fastest with respect to k-points, if the exchange (Eq. (12) in reference {{cite|harl:2010}}) and correlation energy are calculated on the same k-point grid, {{TAG|HFRCUT}}= is not set, and the long-wavelength contributions from the polarizability are not considered  (see reference {{cite|harl:2010}}).
For metals, the RPA groundstate energy converges the fastest with respect to k-points, if the exchange (Eq. (12) in reference {{cite|harl:2010}}) and correlation energy are calculated on the same k-point grid, {{TAG|HFRCUT}} is not set, and the long-wavelength contributions from the polarizability are not considered  (see reference {{cite|harl:2010}}).


To evaluate Eq. (12), a correction energy for <math>E_{\mathrm{EXX}}</math> related to partial occupancies has to be added to the RPA groundstate energy:{{cite|harl:2010}}
To evaluate Eq. (12), a correction energy for <math>E_{\mathrm{EXX}}</math> related to partial occupancies has to be added to the RPA groundstate energy:{{cite|harl:2010}}


<math>\mathrm{E}_{\mathrm{RPA}}=\mathrm{E}_{\mathrm{c}}+\mathrm{E}_{\mathrm{EXX}}+\mathrm{E}_{\mathrm{HFc}}</math>.
<math>E_{\mathrm{RPA}}=E_{\mathrm{c}}+E_{\mathrm{EXX}}+E_{\mathrm{HFc}}</math>.


In vasp.5.4.1, this value is calculated for any HF type calculation (step 2) and can be found in the {{TAG|OUTCAR}} file after the total energy (in the line starting with ''exchange ACFDT corr.  ='').
In vasp.5.4.1, this value is calculated for any HF type calculation (step 2) and can be found in the {{TAG|OUTCAR}} file after the total energy (in the line starting with ''exchange ACFDT corr.  ='').


To neglect the long-wavelength contributions, simply set {{TAG|LOPTICS}}=''.FALSE.'' in the {{TAG|ALGO}}=''Exact'' step (third step), and remove the {{TAG|WAVEDER}} files in the directory.
To neglect the long-wavelength contributions, simply set {{TAG|LOPTICS}}=''.FALSE.'' in the {{TAG|ALGO}}=''Exact'' step (third step), and remove the {{TAG|WAVEDER}} files in the directory.
<span id="basis_cutoff">


== Possible tests and known issues ==
== Possible tests and known issues ==
Line 120: Line 211:
{{:Basis set convergence of RPA-ACFDT calculations}}
{{:Basis set convergence of RPA-ACFDT calculations}}
Convergence with respect to the number of plane waves can be rather slow, and we recommend to test the calculations carefully. Specifically, the calculations should be performed at the default energy cutoff {{TAG|ENCUT}}, and at an increased cutoff (ideally the default energy cutoff <math>\times 1.3</math>). Another issue is that energy volume-curves are sometimes not particularly smooth. In that case, the best strategy is to set
Convergence with respect to the number of plane waves can be rather slow, and we recommend to test the calculations carefully. Specifically, the calculations should be performed at the default energy cutoff {{TAG|ENCUT}}, and at an increased cutoff (ideally the default energy cutoff <math>\times 1.3</math>). Another issue is that energy volume-curves are sometimes not particularly smooth. In that case, the best strategy is to set
  {{TAGBL|ENCUT}} = 1.3 times default cutoff energy
  {{TAGBL|ENCUT}} = 1.3 times default energy cutoff
  {{TAGBL|ENCUTGWSOFT}} = 0.5 times default cutoff energy
  {{TAGBL|ENCUTGWSOFT}} = 0.5 times default energy cutoff


where the default cutoff energy is the usual cutoff energy (maximum ENMAX in POTCAR files). The frequency integration also needs to be checked carefully, in particular for small gap systems (some symmetry broken atoms) convergence can be rather slow, since the one-electron band gap can be very small, requiring a very small minimum <math>\omega</math> in the frequency integration.
where the default energy cutoff is the usual one (maximum ENMAX in POTCAR files). The frequency integration also needs to be checked carefully, in particular for small gap systems (some symmetry broken atoms) convergence can be rather slow, since the one-electron band gap can be very small, requiring a very small minimum <math>\omega</math> in the frequency integration.
</span>


== Related Tags and Sections ==
== Related Tags and Sections ==
Line 136: Line 228:
* {{TAG|NTAUPAR}} controls the number of imaginary time groups in space-time GW and RPA calculations
* {{TAG|NTAUPAR}} controls the number of imaginary time groups in space-time GW and RPA calculations
* {{TAG|NOMEGAPAR}} controls the number of imaginary frequency groups in space-time GW and RPA calculations
* {{TAG|NOMEGAPAR}} controls the number of imaginary frequency groups in space-time GW and RPA calculations
* {{TAG|MAXMEM}} sets the available memory per MPI rank on each node
* {{TAG|LFINITE_TEMPERATURE}} switches on Matsubara (finite temperature) formalism


== References ==
== References ==
Line 142: Line 236:
----
----


[[Category:Many-Body Perturbation Theory]][[Category:ACFDT]][[Category:Howto]]
[[Category:Many-body perturbation theory]][[Category:ACFDT]][[Category:Howto]][[Category:Low-scaling GW and RPA]]

Latest revision as of 14:36, 20 February 2024

The adiabatic-connection-fluctuation-dissipation theorem (ACFDT) can be used to derive the random-phase approximation (RPA). The ACFDT-RPA ground-state energy is the sum of the ACFDT-RPA correlation energy and the Hartree-Fock (HF) energy evaluated non self-consistently using Kohn-Sham orbitals computed within density-functional theory (DFT):

.

Note that, here includes also the Hartree energy, the kinetic energy, as well as the Ewald energy of the ions, whereas often in literature refers only to the exact-exchange (EXX) energy evaluated using DFT orbitals.

If ALGO=RPA is set in the INCAR file, VASP calculates the correlation energy within RPA. To this end, VASP first calculates the independent-particle response function, using the unoccupied states given in the WAVECAR file, and then determines the correlation energy using the plasmon-fluctuation equation:

.

More information about the theory behind the RPA is found here.

General recipe to calculate ACFDT-RPA total energies

The ACFDT-RPA total energies can be computed in a four-step procedure or in an all-in-one approach. The all-in-one approach is available as of VASP.6 and can be done in one single step. Both procedures comprise a self-consistent DFT calculation, diagonalizing the KS Hamiltonian, and the RPA calculation itself. While the all-in-one approach is very convenient, there are several caveats discussed below.

Four-step procedure to calculate ACFDT-RPA total energy

This four-step procedure is the standard procedure in VASP.5, and is also available in VASP.6 by setting NBANDS in the RPA step.

Step 1: a standard DFT run.

All occupied orbitals (and as usual in VASP, a few unoccupied orbitals) of the DFT Hamiltonian are calculated. For instance,
EDIFF = 1E-8 # required for convergence of RPA total energies
ISMEAR = 0 ; SIGMA = 0.05
Warning: The convergence of DFT eigenenergies influences the convergence of the RPA correlation energy.
Tip: Use the Perdew-Burke-Ernzerhof (PBE) pseudopotentials with a small EDIFF and avoid ISMEAR>0.
The DFT run can be done with your favorite setup, but we recommend attaining very high precision (small EDIFF tag) and to use a small smearing width (SIGMA tag), and to avoid higher-order Methfessel-Paxton smearing (see also ISMEAR). That is because Methfessel-Paxton smearing can lead to negative one-electron occupancies, which can result in unphysical correlation energies. We suggest using PBE orbitals as input for the ACFDT-RPA run, but other choices, e.g., local-density-approximation (LDA) or hybrids, are possible as well. For hybrid functionals, we suggest carefully considering the caveats mentioned in Ref. [1]. Specifically, the RPA dielectric matrix yields too weak screening for hybrid functionals, which potentially deteriorates RPA results.

Step 2: Compute the HF energy using the DFT orbitals. That is, e.g.,

ALGO  = EIGENVAL ; NELM = 1
LWAVE = .FALSE.                ! WAVECAR not written     
LHFCALC = .TRUE. ; AEXX = 1.0  ! ALDAC = 0.0 
ISMEAR = 0 ; SIGMA = 0.05
Here, LWAVE = .FALSE. avoids an accidental update of the WAVECAR file. Also, VASP automatically sets ALDAC = 1-AEXX, i.e., for AEXX = 1.0, ALDAC = 0.0.
Tip: For insulators and semiconductors with a sizable gap, faster k-point convergence of the HF energy can be obtained by setting HFRCUT=-1, although this slows convergence for metals.

Step 3: Compute a sufficient number of unoccupied states.

In the OUTCAR file of Step 1, search for maximum number of plane-waves: and run VASP again with the following INCAR file to determine the unoccupied states by exact diagonalization of the KS Hamiltonian. The KS Hamiltonian must be the same as in step 1, which might be DFT or hybrid.
NBANDS = maximum number of plane-waves (times 2 for vasp_gam)
ALGO = Exact    ! exact diagonalization
EDIFF = 1E-8 # required for convergence of RPA total energies
LOPTICS = .TRUE.
ISMEAR = 0 ; SIGMA = 0.05
For calculations using vasp_gam, that is the gamma-point only version of VASP, NBANDS must be set to twice the maximum number of plane-waves: found in the OUTCAR file of Step 1. For metals, we recommend to avoid setting LOPTICS=.TRUE., since this slows down k-point convergence .

Step 4: Calculate the ACFDT-RPA correlation energy.

NBANDS =  maximum number of plane-waves
ALGO = ACFDT
NOMEGA = 12     ! default
ISMEAR = 0 ; SIGMA = 0.05 
The number of imaginary-frequency and imaginary-time-grid points NOMEGA is usually set to 8-24. For large gap insulators NOMEGA = 8 will suffice, while for semiconductors 10-12 suffices.
Important: For VASP 6.X, NBANDS must be set in this step.

All-in-one approach to calculate ACFDT-RPA total energy

VASP will read the WAVECAR file, perform a self-consistent DFT calculation by iterating until convergence is reached, diagonalize the DFT Hamiltonian in the basis set spanned by all KS orbitals, and finally proceed with the RPA calculation. The all-in-one approach is only available as of VASP.6, and it is particularly convenient for the RPAR and GWR algorithms. An example INCAR file is

ALGO = RPAR

EDIFF = 1E-8  # required for convergence of RPA total energies
ISMEAR = 0 ; SIGMA = 0.05
 
NOMEGA = 8-24    ! for large gap insulators NOMEGA = 8 will suffice, for semiconductors 10-12 suffices
   
LOPTICS = .TRUE. ! optional 
LPEAD = .TRUE.   ! required for 6.1 and 6.2 if LOPTICS = .TRUE.
Warning: The tag NBANDS must not be set in the INCAR file.
Warning: The convergence of DFT eigenenergies influences the convergence of the RPA correlation energy.
Tip: Use the Perdew-Burke-Ernzerhof (PBE) pseudopotentials with a small EDIFF and avoid ISMEAR>0.

The head of the dielectric function can be calculated only for insulators by setting the LOPTICS tag and only the Perturbation-Expression-After-Discretization (PEAD) method is supported, see LPEAD. Furthermore, EDIFF should be small to calculate the DFT orbitals with high precision. Although it is not strictly required, we recommend starting the calculation from a well-converged DFT WAVECAR file.

There are several caveats to the all-in-one approach:

  • There is no general support for ACFDT/RPA on top of hybrid functionals. In VASP 6.2, only LDA and gradient corrected functionals are supported. As of VASP 6.2, the all-in-one approach can be used for Hartree-Fock-type calculations, as well as hybrid functionals without range separation. However, range-separated hybrid functionals (including HSE, LMODELHF) yield erroneous results or potentially even crash. Please compare the total energies in a standard DFT/hybrid functional calculation against the energies obtained for the mean-field step in the all-in-one approach: The energies must be exactly the same. If they differ, fall back to the four-step procedure that is explained above.
  • To select the new all-in-one approach, it is important "not to set NBANDS" in the RPA step. If NBANDS is set in the INCAR file, VASP.6 proceeds with reading the WAVECAR file found in the directory (if not present, random orbitals are used!), and then calculates the correlation energy using these orbitals and one-electron energies.
  • The basis set used in the diagonalization is strictly given by all plane waves. That is, there is no option to reduce the basis set size as one can by setting NBANDS in Step 3 and Step 4 of the four-step procedure.
  • The exchange energy is only calculated if the low-scaling RPA is selected.
  • As of VASP 6.3, the head of the dielectric function (G=0 component) can be calculated by setting LOPTICS = .TRUE.
  • In the all-in-one procedure, VASP automatically sets LMAXFOCKAE and NMAXFOCKAE. This changes the energies for hybrid functionals and Hartree-Fock slightly. Hence, you need to set LMAXFOCKAE = 4 also in Step 1 of the four-step procedure to obtain the same results as in the all-in-one procedure.

Output of ACFDT-RPA total energy

The ACFDT-RPA total energy is calculated for 8 different energy cutoffs and a linear regression is used to extrapolate the results to the infinite cutoff limit, see section below. A successful RPA calculation writes the following lines into the OUTCAR file:

      cutoff energy     smooth cutoff   RPA   correlation   Hartree contr. to MP2
---------------------------------------------------------------------------------
            316.767           316.767      -17.5265976349      -26.2640927215
            301.683           301.683      -17.3846505665      -26.0990489039
            287.317           287.317      -17.2429031341      -25.9344769084
            273.635           273.635      -17.0686574017      -25.7325162480
            260.605           260.605      -16.8914915810      -25.5277026697
            248.195           248.195      -16.7202601717      -25.3302982602
            236.376           236.376      -16.5559849344      -25.1415392478
            225.120           225.120      -16.3635400223      -24.9210737434
  linear regression    
  converged value                          -19.2585393615      -28.2627347266

Here, the third and fourth columns correspond to the correlation energy (for that specific energy cutoff) in the RPA and the direct second-order Møller–Plesset (MP2) approximation, i.e., the second-order term in RPA. The corresponding results of the linear regression are found in the line starting with converged value.

Low-scaling ACFDT/RPA algorithm

Virtually the same tags and procedures apply to the low-scaling RPA algorithm implemented in VASP 6 [2]. However, ALGO=ACFDT or ALGO=RPA needs to be replaced by either ALGO=ACFDTR or ALGO=RPAR.

With this setting VASP calculates the independent-particle polarizability using Green's functions on the imaginary time axis by the contraction formula [3]

Subsequently, a compressed Fourier transformation on the imaginary axes yields

The remaining step is the evaluation of the correlation energy and is the same as described above.

Crucial to this approach is the accuracy of the Fourier transformation from , which in general depends on two factors: First, the grid order that can be set by NOMEGA in the INCAR file. Here, similar choices as for the ALGO=ACFDT are recommended. Second, the grid points and Fourier matrix have to be optimized for the same interval as spanned by all possible transition energies in the polarizability. The minimum (maximum) transition energy can be set with the OMEGAMIN (OMEGATL) tag and should be smaller (larger) than the bandgap, i.e., the maximum transition energy, of the previous DFT calculation. VASP determines these values automatically and writes it in the OUTCAR after the lines

Response functions by GG contraction: 

These values should be checked for consistency. Furthermore, we recommend inspecting the grid and transformation errors by looking for the following lines in the OUTCAR file

nu_ 1=  0.1561030E+00 ERR=   0.6327933E-05 finished after   1 steps    
nu_ 2= ...
Maximum error of frequency grid:  0.3369591E-06

Every frequency point will have a similar line as shown above for the first point. The value after ERR= corresponds to the maximum Fourier-transformation error and should be of similar order as the maximum integration error of the frequency grid.

Output of low-scaling ACFDT/RPA

Selecting the low-scaling RPA algorithm, VASP computes the total energy in the RPA and writes the following output

 -----------------------------------------------------
 HF-free energy      FHF    =       -25.11173505 eV
 HF+RPA corr. energy TOTEN  =       -36.96463791 eV
 HF+E_corr(extrapolated)    =       -37.70506951 eV

The line HF+RPA corr. energy TOTEN contains the total energy calculated with the largest cutoff ENCUTGW. The line HF+E_corr(extrapolated) contains the total energy with the extrapolated value for the RPA correlation energy.

Singles contribution to the correlation energy

The low-scaling RPA algorithm also allows for the determination of the so-called singles contribution,[4][5] to the total energy represented by following diagrams:

In most textbooks[6] this contribution is assumed to be zero. Ren et al.[5] pointed out that this is true only in the Hartree-Fock basis set. The singles contribution is non-vanishing for other basis sets.

The singles contribution is calculated for LSINGLES=.TRUE.. In this case following additional lines can be found in OUTCAR:

HF single shot energy change        -1.23182672
renormalized HF singles             -1.23310555

Here, the first line contains the value of the singles as proposed by Klimeš et al.,[4] while the second line contains the singles contribution of Ren et al.[5]. In most cases we found that the two values are exceedingly close to each other, which can be understood in the way how the propagator is renormalized.[4]

Optional: RPA Forces

Optionally, RPA forces can be calculated by adding following line to the INCAR file:

 LRPAFORCE = .TRUE. 

For RPA forces the change in the one-electron density is required.[7] This is automatically performed with the linear-response routine within VASP. After a successful run, the following block of data is found in the OUTCAR file.

POSITION                                       TOTAL RPA FORCE (eV/Angst)
-----------------------------------------------------------------------------------
     0.17542     -0.22348      0.17542        -0.292069      7.581315     -0.292069
     1.12850      1.31044      1.12850         0.304683     -7.605527      0.304683
-----------------------------------------------------------------------------------
   total drift:                                0.012614     -0.024212      0.012614

SUGGESTED UPDATED POSCAR (direct coordinates)  step
-----------------------------------------------------------------------------------
 -0.00958461  -0.00958461   0.13485779         0.04179056   0.04179056   0.00283088
  0.25787833   0.25787833   0.22191754        -0.04337198  -0.04337198   0.00431513
Warning: The RPA forces computed for metallic systems are currently not supported.

The suggested updated positions are also written to the CONTCAR file (if NSW=0). The updated positions are obtained by multiplying the RPA-forces with the parameter DAMP_NEWTON and the inverse of the DFT-Hessian (which is also calculated during the RPA force calculations) and adding the resultant vector to the current positions. DAMP_NEWTON currently defaults to 0.8, but the user might want to change this to 1.0 (no damping), or smaller values if instabilities are observed. The CONTCAR file can be copied to the POSCAR file, and a few such RPA calculations should recover the groundstate structure. Alternatively, standard relaxations (IBRION =1-4) or even MD's can be performed.

Memory bottleneck and Parallelization

The cubic scaling space-time RPA algorithm requires considerably more memory than the corresponding quartic-scaling implementations, two Green's functions have to be stored in real-space. To reduce the memory overhead, VASP exploits Fast Fourier Transformations (FFT) to avoid storage of the matrices on the (larger) real space grid, on the one hand. The precision of the FFT can be selected with PRECFOCK, where usually the values Fast sufficient.

On the other hand, the code avoids storage of redundant information, i.e., both the Green's function and polarizability matrices are distributed as well as the individual imaginary grid points. The distribution of the imaginary grid points can be set by hand with the NTAUPAR and NOMEGAPAR tags, which splits the imaginary grid points NOMEGA into NTAUPAR time and NOMEGAPAR groups. For this purpose both tags have to be divisors of NOMEGA.

The default values are usually reasonable choices provided the tag MAXMEM is set correctly and we strongly recommend to set MAXMEM instead of NTAUPAR.

Important: As of version 6.2, MAXMEM is estimated automatically (if not set) from the "MemAvailable" entry of the Linux kernel in "/proc/meminfo".

The required storage for a low-scaling RPA or GW calculation depends mostly on NTAUPAR, the number of MPI groups that share same imaginary time points. A rough estimate for the required bytes is given by

(NGX*NGY*NGZ)*(NGX_S*NGY_S*NGZ_S) / ( NCPU  / NTAUPAR ) * 16

where "NCPU" is the number of MPI ranks used for the job,"NGX,NGY,NGZ" denotes the number of FFT grid points for the exact exchange and "NGX_S,NGY_S,NGZ_S" the number of FFT grid points for the supercell. Note, both grids are written to the OUTCAR file after the lines

FFT grid for exact exchange (Hartree Fock)
FFT grid for supercell:

The smaller NTAUPAR is set, the less memory per node the job requires to finish successfully.

The approximate memory requirement is calculated in advance and printed to screen and OUTCAR as follows:

min. memory requirement per mpi rank 1234 MB, per node 9872 MB

Some Issues Particular to ACFDT-RPA Calculations on Metals

For metals, the RPA groundstate energy converges the fastest with respect to k-points, if the exchange (Eq. (12) in reference [8]) and correlation energy are calculated on the same k-point grid, HFRCUT is not set, and the long-wavelength contributions from the polarizability are not considered (see reference [8]).

To evaluate Eq. (12), a correction energy for related to partial occupancies has to be added to the RPA groundstate energy:[8]

.

In vasp.5.4.1, this value is calculated for any HF type calculation (step 2) and can be found in the OUTCAR file after the total energy (in the line starting with exchange ACFDT corr. =).

To neglect the long-wavelength contributions, simply set LOPTICS=.FALSE. in the ALGO=Exact step (third step), and remove the WAVEDER files in the directory.

Possible tests and known issues

Basis set convergence

The expression for the ACFDT-RPA correlation energy written in terms of reciprocal lattice vectors reads:

.

The sum over reciprocal lattice vectors has to be truncated at some , determined by < ENCUTGW, which can be set in the INCAR file. The default value is ENCUT, which experience has taught us not to change. For systematic convergence tests, instead increase ENCUT and repeat steps 1 to 4, but be aware that the "maximum number of plane-waves" changes when ENCUT is increased. Note that it is virtually impossible, to converge absolute correlation energies. Rather concentrate on relative energies (e.g. energy differences between two solids, or between a solid and the constituent atoms).

Since correlation energies converge very slowly with respect to , VASP automatically extrapolates to the infinite basis set limit using a linear regression to the equation: [9][8][10]

.

Furthermore, the Coulomb kernel is smoothly truncated between ENCUTGWSOFT and ENCUTGW using a simple cosine like window function (Hann window function). Alternatively, the basis set extrapolation can be performed by setting LSCK=.TRUE., using the squeezed Coulomb kernel method.[11]

The default for ENCUTGWSOFT is 0.8ENCUTGW (again we do not recommend to change this default).

The integral over is evaluated by means of a highly accurate minimax integration.[12] The number of points is determined by the flag NOMEGA, whereas the energy range of transitions is determined by the band gap and the energy difference between the lowest occupied and highest unoccupied one-electron orbital. VASP determines these values automatically (from vasp.5.4.1 on), and the user should only carefully converge with respect to the number of frequency points NOMEGA. A good choice is usually NOMEGA=12, however, for large gap systems one might obtain eV convergence per atom already using 8 points, whereas for metals up to NOMEGA=24 frequency points are sometimes necessary, in particular, for large unit cells.

Strictly adhere to the steps outlines above. Specifically, be aware that steps two and three require the WAVECAR file generated in step one, whereas step four requires the WAVECAR and WAVEDER file generated in step three (generated by setting LOPTICS=.TRUE.).

Convergence with respect to the number of plane waves can be rather slow, and we recommend to test the calculations carefully. Specifically, the calculations should be performed at the default energy cutoff ENCUT, and at an increased cutoff (ideally the default energy cutoff ). Another issue is that energy volume-curves are sometimes not particularly smooth. In that case, the best strategy is to set

ENCUT = 1.3 times default energy cutoff
ENCUTGWSOFT = 0.5 times default energy cutoff

where the default energy cutoff is the usual one (maximum ENMAX in POTCAR files). The frequency integration also needs to be checked carefully, in particular for small gap systems (some symmetry broken atoms) convergence can be rather slow, since the one-electron band gap can be very small, requiring a very small minimum in the frequency integration.

Related Tags and Sections

  • ALGO for response functions and ACFDT calculations
  • NOMEGA, NOMEGAR number of frequency points
  • LHFCALC, switches on HF calculations
  • LOPTICS, required in the DFT step to store head and wings
  • ENCUTGW, to set cutoff for response functions
  • ENCUTGWSOFT
  • PRECFOCK controls the FFT grids in HF, GW, RPA calculations
  • NTAUPAR controls the number of imaginary time groups in space-time GW and RPA calculations
  • NOMEGAPAR controls the number of imaginary frequency groups in space-time GW and RPA calculations
  • MAXMEM sets the available memory per MPI rank on each node
  • LFINITE_TEMPERATURE switches on Matsubara (finite temperature) formalism

References