Time-propagation TDDFT

Optical photoabsorption spectrum as well as nonlinear effects can be studied using time propagation TDDFT. This approach scales better than linear response, but the prefactor is so large that for small and moderate systems linear response is significantly faster.

Ground state

To obtain the ground state for TDDFT, one has to just do a standard ground state with a larger simulation box. A proper distance from any atom to edge of the simulation box is problem dependent, but a minimum reasonable value is around 6 Ångströms and recommended between 8-10 Ång. In TDDFT, one can use larger grid spacing than for geometry optimization. For example, if you use h=0.25 for geometry optimization, try h=0.3 for TDDFT. This saves a lot of time.

A good way to start is to use too small box (vacuum=6.0), too large grid spacing (h=0.35), and too large time step (dt=16.0). Then repeat the simulation with better parameter values and compare. Probably lowest peaks are already pretty good, and far beyond the ionization limit, in the continuum, the spectrum is not going to converge anyway. The first run takes only fraction of the time of the second run.

For a parallel-over-states TDDFT calculation, you must choose the number of states so, that these can be distributed equally to processors. For example, if you have 79 occupied states and you want to use 8 processes in parallelization over states, add one unoccupied state to get 80 states in total.

Point group symmetries are disabled in TDDFT, since the symmetry is broken by the time-dependent potential. Therefore, they have to be disabled in the ground state calculation as well. In GPAW versions starting from 22.8.1b1, the TDDFT calculation will refuse to start if the ground state has been converged with point group symmetries enabled.

Ground state example:

# Standard magic
from ase import Atoms
from gpaw import GPAW

# Beryllium atom
atoms = Atoms(symbols='Be',
              positions=[(0, 0, 0)],
              pbc=False)

# Add 6.0 ang vacuum around the atom
atoms.center(vacuum=6.0)

# Create GPAW calculator
calc = GPAW(mode='fd', nbands=1, h=0.3, symmetry={'point_group': False})
# Attach calculator to atoms
atoms.calc = calc

# Calculate the ground state
energy = atoms.get_potential_energy()

# Save the ground state
calc.write('be_gs.gpw', 'all')

Time-propagation TDDFT is also available in LCAO mode.

Optical photoabsorption spectrum

Optical photoabsorption spectrum can be obtained by applying a weak delta pulse of dipole electric field, and then letting the system evolve freely while recording the dipole moment. A time-step around 4.0-8.0 attoseconds is reasonable. The total simulation time should be few tens of femtoseconds depending on the desired resolution.

Example:

from gpaw.tddft import *

time_step = 8.0                  # 1 attoseconds = 0.041341 autime
iterations = 2500                # 2500 x 8 as => 20 fs
kick_strength = [0.0,0.0,1e-3]   # Kick to z-direction

# Read ground state
td_calc = TDDFT('be_gs.gpw')

# Save the time-dependent dipole moment to 'be_dm.dat'
DipoleMomentWriter(td_calc, 'be_dm.dat')

# Use 'be_td.gpw' as restart file
RestartFileWriter(td_calc, 'be_td.gpw')

# Kick with a delta pulse to z-direction
td_calc.absorption_kick(kick_strength=kick_strength)

# Propagate
td_calc.propagate(time_step, iterations)

# Save end result to 'be_td.gpw'
td_calc.write('be_td.gpw', mode='all')

# Calculate photoabsorption spectrum and write it to 'be_spectrum_z.dat'
photoabsorption_spectrum('be_dm.dat', 'be_spectrum_z.dat')

When propagating after an absorption kick has been applied, it is a good idea to periodically write the time-evolution state to a restart file. This ensures that you can resume adding data to the dipole moment file if you experience artificial oscillations in the spectrum because the total simulation time was too short.

Example:

from gpaw.tddft import *

time_step = 8.0                  # 1 attoseconds = 0.041341 autime
iterations = 2500                # 2500 x 8 as => 20 fs

# Read restart file with result of previous propagation
td_calc = TDDFT('be_td.gpw')

# Append the time-dependent dipole moment to the already existing 'be_dm.dat'
DipoleMomentWriter(td_calc, 'be_dm.dat')

# Use 'be_td2.gpw' as restart file
RestartFileWriter(td_calc, 'be_td2.gpw')

# Propagate more
td_calc.propagate(time_step, iterations)

# Save end result to 'be_td2.gpw'
td_calc.write('be_td2.gpw', mode='all')

# Recalculate photoabsorption spectrum and write it to 'be_spectrum_z2.dat'
photoabsorption_spectrum('be_dm.dat', 'be_spectrum_z2.dat')

Typically in experiments, the spherically averaged spectrum is measured. To obtain this, one must repeat the time-propagation to each Cartesian direction and average over the Fourier transformed dipole moments.

Fourier transformed density and electric near field

To analyze the resonances seen in the photoabsorption spectrum, see Induced density oscillations and electric near field from TDDFT.

Time propagation

Since the total CPU time also depends on the number of iterations performed by the linear solvers in each time-step, smaller time-steps around 2.0-4.0 attoseconds might prove to be faster with the ECN and SICN propagators because they have an embedded Euler step in each predictor step:

\[\tilde{\psi}_n(t+\Delta t) \approx (1 - i \hat{S}^{\;-1}_\mathrm{approx.}(t) \tilde{H}(t) \Delta t)\tilde{\psi}_n(t)\]

, where \(\hat{S}^{\;-1}_\mathrm{approx.}\) is an inexpensive operation which approximates the inverse of the overlap operator \(\hat{S}\). See the Developers Guide for details.

Therefore, as a rule-of-thumb, choose a time-step small enough to minimize the number of iterations performed by the linear solvers in each time-step, but large enough to minimize the number of time-steps required to arrive at the desired total simulation time.

TDDFT reference manual

class gpaw.tddft.TDDFT(filename, *, td_potential=None, calculate_energy=True, propagator=None, solver=None, tolerance=None, parallel=None, communicator=None, txt='-')[source]

Time-dependent density functional theory calculation based on GPAW.

This class is the core class of the time-dependent density functional theory implementation and is the only class which a user has to use.

Parameters:
  • filename (str) – File containing ground state or time-dependent state to propagate.

  • td_potential (object) – Function class for the time-dependent potential. Must have a method strength(time) which returns the strength of the linear potential to each direction as a vector of three floats.

  • calculate_energy (bool) – Whether to calculate energy during propagation.

  • propagator (dict) – Time propagator for the Kohn-Sham wavefunctions.

  • solver (dict) – The iterative linear equations solver for propagator.

  • tolerance (float) – Deprecated. Do not use this, but use solver dictionary instead. Tolerance for the linear solver.

  • parallel (dict) – Parallelization options

  • communicator (object) – MPI communicator

  • txt (str) – Text output

absorption_kick(kick_strength)[source]

Delta absorption kick for photoabsorption spectrum.

Parameters:

kick_strength – Strength of the kick in atomic units

get_td_energy()[source]

Calculate the time-dependent total energy

propagate(time_step, iterations, dipole_moment_file=None, restart_file=None, dump_interval=None)[source]

Propagates wavefunctions.

Parameters:
  • time_step (float) – Time step in attoseconds (10^-18 s).

  • iterations (int) – Number of iterations.

  • dipole_moment_file (Optional[str]) – Deprecated. Do not use this. Name of the data file where to the time-dependent dipole moment is saved.

  • restart_file (Optional[str]) – Deprecated. Do not use this. Name of the restart file.

  • dump_interval (Optional[int]) – Deprecated. Do not use this. After how many iterations restart data is dumped.

class gpaw.tddft.DipoleMomentWriter(paw, filename, *, center=False, density='comp', force_new_file=False, interval=1)[source]

Observer for writing time-dependent dipole moment data.

The data is written in atomic units.

The observer attaches to the TDDFT calculator during creation.

Parameters:
  • paw – TDDFT calculator

  • filename (str) – File for writing dipole moment data

  • center (bool) – If true, dipole moment is evaluated with the center of cell as the origin

  • density (str) – Density type used for evaluating dipole moment. Use the default value for production calculations; others are for testing purposes. Possible values: 'comp': rhot_g, 'pseudo': nt_sg, 'pseudocoarse': nt_sG.

  • force_new_file (bool) – If true, new dipole moment file is created (erasing any existing one) even when restarting time propagation.

  • interval (int) – Update interval. Value of 1 corresponds to evaluating and writing data after every propagation step.

class gpaw.tddft.MagneticMomentWriter(paw, filename, *, origin=None, origin_shift=None, dmat=None, calculate_on_grid=None, only_pseudo=None, interval=1)[source]

Observer for writing time-dependent magnetic moment data.

The data is written in atomic units.

The observer attaches to the TDDFT calculator during creation.

Parameters:
  • paw – TDDFT calculator

  • filename (str) – File for writing magnetic moment data

  • origin (str) – Origin of the coordinate system used in calculation. Possible values: 'COM': center of mass (default), 'COC': center of cell, 'zero': (0, 0, 0)

  • origin_shift (Union[Sequence[float], ndarray]) – Vector in Å shifting the origin from the position defined by origin.

  • dmat (DensityMatrix) – Density matrix object. Define this for LCAO calculations to avoid expensive recalculations of the density matrix.

  • calculate_on_grid (bool) – Parameter for testing. In LCAO mode, if true, calculation is performed on real-space grid. In fd mode, calculation is always performed on real-space grid and this parameter is neglected.

  • only_pseudo (bool) – Parameter for testing. If true, PAW corrections are neglected.

  • interval (int) – Update interval. Value of 1 corresponds to evaluating and writing data after every propagation step.

class gpaw.tddft.RestartFileWriter(paw, restart_filename, interval=100)[source]

Observer for writing restart files periodically.

At the given interval, the calculator restart file is written and write_restart() of every attached observer is called.

The observer attaches to the TDDFT calculator during creation.

Parameters:
  • paw – TDDFT calculator

  • restart_filename – File for writing the calculator object

  • interval – Update interval. The restart files are written every that many propagation steps.

gpaw.tddft.photoabsorption_spectrum(dipole_moment_file, spectrum_file, folding='Gauss', width=0.2123, e_min=0.0, e_max=30.0, delta_e=0.05)[source]

Calculates photoabsorption spectrum from the time-dependent dipole moment.

The spectrum is represented as a dipole strength function in units of 1/eV. Thus, the resulting spectrum should integrate to the number of valence electrons in the system.

Parameters:
  • dipole_moment_file (str) – Name of the time-dependent dipole moment file from which the spectrum is calculated

  • spectrum_file (str) – Name of the spectrum file

  • folding (str) – Gaussian ('Gauss') or Lorentzian ('Lorentz') folding

  • width (float) – Width of the Gaussian (sigma) or Lorentzian (Gamma) Gaussian = 1/(sigma sqrt(2pi)) exp(-(1/2)(omega/sigma)^2) Lorentzian = (1/pi) (1/2) Gamma / [omega^2 + ((1/2) Gamma)^2]

  • e_min (float) – Minimum energy shown in the spectrum (eV)

  • e_max (float) – Maximum energy shown in the spectrum (eV)

  • delta_e (float) – Energy resolution (eV)

class gpaw.lcaotddft.densitymatrix.DensityMatrix(paw)[source]