Phonon dispersion relations
Short description
Calculate phonon dispersions and related quantities. Per default, only the dispersions along a default path will be calculated. Options are available for calculating mode gruneisen parameters, phonon density of states projected in a variety of ways, thermodynamic quantities and pure data dumps.
Command line options:
Optional switches:
-
--unit value
, value in:thz,mev,icm
default value thz
Choose the output unit. The options are terahertz (in frequency, not angular frequency), inverse cm or meV. -
--nq_on_path value
,-nq value
default value 100
Number of q-points between each high symmetry point -
--readpath
,-rp
default value .false.
Read the q-point path frominfile.qpoints_dispersion
. Use crystal structure into to generate an example. -
--dos
default value .false.
Calculate the phonon DOS -
--qpoint_grid value#1 value#2 value#3
,-qg value#1 value#2 value#3
default value 26 26 26
Density of q-point mesh for Brillouin zone integrations. -
--meshtype value
, value in:1,2,3,4
default value 1
Type of q-point mesh. 1 Is a Monkhorst-Pack mesh, 2 an FFT mesh and 3 my fancy wedge-based mesh with approximately the same density the grid-based meshes. 4 build the commensurate mesh of an approximately cubic supercell. -
--sigma value
default value 1.0
Global scaling factor for Gaussian/adaptive Gaussian smearing. The default is determined procedurally, and scaled by this number. -
--readqmesh
default value .false.
Read the q-point mesh from file. To generate a q-mesh file, see the genkpoints utility. -
--integrationtype value
,-it value
, value in:1,2,3
default value 2
Type of integration for the phonon DOS. 1 is Gaussian, 2 adaptive Gaussian and 3 Tetrahedron. -
--dospoints value
default value 400
Number of points on the frequency axis of the phonon dos. -
--gruneisen
default value .false.
Use third order force constants to calculate mode Gruneisen parameters. -
--dumpgrid
default value .false.
Write files with q-vectors, frequencies, eigenvectors and group velocities for a grid. -
--help
,-h
Print this help message -
--version
,-v
Print version
Examples
phonon_dispersion_relations
phonon_dispersion_relations --dos --qpoint_grid 24 24 24
What does this code produce?
This code calculates phonon dispersion relations, usually presented like this:

Where the color of the line indicates the projection onto species. The same data can also be presented as a density of states, like this:

By default, minimal input is needed, but many options to tailor the output exist.
Equations of motion in a harmonic crystal
As detailed in extract forceconstants we have mapped the Born-Oppenheimer to an effective potential. A model Hamiltonian truncated at the second order (a harmonic Hamiltonian) is given by1
Where
such that
Here we expanded the atom index
I prefer a truncated notation:
Where
Here the displacements are expressed as a sum of plane waves, or normal modes, each with wave vector
where the periodic boundary conditions limit the choices of
This is the Fourier transform of the mass-weighted force constant matrix, where each
The eigenvalues
By calculating the eigenvalues and eigenvectors of the dynamical matrix over the Brillouin zone, all thermodynamic quantities involving the atomic motions can be determined, as far as the harmonic approximation is valid. If you are curious where the amplitudes of the normal modes disappeared, see canonical configuration.
Long-ranged interactions in polar materials
When determining the dynamical matrix, the sum over lattice vectors -rc2
), and truncate the sum. This is not a valid approach when dealing with polar material where the induced dipole-dipole interactions are essentially infinite-ranged. See for example Gonze & Lee.5 6 When dealing with these long-ranged electrostatics we start by defining the Born effective charge tensor:
That is the mixed derivative of the energy with respect to electric field
The pairwise dipole-dipole interactions can be expressed as forceconstants:
Here
This poses an issue when calculating the dynamical matrix: the interactions die off as
Dividing the sum into a realspace part, a reciprocal part and a connecting part. The realspace part is given by
where
In reciprocal space we have
where
and finally a connecting part given by
This expression is invariant for any
Separation into short- and long-range interactions
Other dispersive properties
We determine group velocities via the Hellman-Feynmann theorem:
where the derivatives of the dynamical matrix are defined above, and
For degenerate modes this is ill-defined, we have to apply degenerate perturbation theory to resolve it. The practical procedure is as follows (this example is for a single component, but the same procedure works in general), first define
where the indices run over the degenerate subspace. The gradient is then
where
The Hessian with respect to
The mode Grüneisen parameters are a measure of the sensitivity of the vibrational frequencies to volume changes. They are given by
where
Here
Density of states
Using --dos
or will calculate the phonon density of states, given by
per mode
that, also sums to the total density of states.
Input files
Optional files:
- infile.qpoints_dispersion (to specify a path for the phonon dispersions)
- infile.forceconstant_thirdorder (for the Grüneisen parameter)
Output files
Depending on options, the set of output files may differ. We start with the basic files that are written.
outfile.dispersion_relations.hdf5
This is a packed up format of all the data. Below is a short matlab snippet to plot parts of it, the hdf5 file is self-explanatory -- it contains all harmonic properties you can think of including some more.
fn='outfile.dispersion_relations.hdf5';
x=h5read(fn,'/q_values');
xtck=h5read(fn,'/q_ticks');
xtckl=strsplit(h5readatt(fn,'/','q_tick_labels'));
y=h5read(fn,'/frequencies');
frequnit=h5readatt(fn,'/frequencies','unit');
figure(1); clf; hold on; box on;
plot(x,y)
set(gca,'xtick',xtck,'xticklabel',xtckl,'yminortick','on');
ylabel(['Frequencies (' frequnit ')'])
xlim([0 max(x)])
'outfile.phonon_dos.hdf5'
Contains the phonon density of states. The file is self-documented, below is a sample matlab snippet that plots it.
fn=('outfile.phonon_dos.hdf5');
unique_atom_labels=strsplit(h5readatt(fn,'/','unique_atom_labels'));
energy_unit=h5readatt(fn,'/frequencies','unit');
dos_unit=h5readatt(fn,'/dos','unit')
omega=h5read(fn,'/frequencies');
dos=h5read(fn,'/dos');
dos_per_mode=h5read(fn,'/dos_per_mode');
dos_per_site=h5read(fn,'/dos_per_site');
dos_per_unique_atom=h5read(fn,'/dos_per_unique_atom');
figure(1); clf;
subplot(1,3,1); hold on; box on;
title('Phonon density of states')
for i=1:size(dos_per_mode,2)
plot(omega,dos)
end
set(gca,'xminortick','on','yminortick','on')
ylabel(['Phonon density of states (' dos_unit ')'])
xlabel(['Frequency (' energy_unit ')'])
subplot(1,3,2); hold on; box on;
title('Phonon density of states per mode')
for i=1:size(dos_per_mode,2)
plot(omega,dos_per_mode(:,i))
end
set(gca,'xminortick','on','yminortick','on')
ylabel(['Phonon density of states (' dos_unit ')'])
xlabel(['Frequency (' energy_unit ')'])
subplot(1,3,3); hold on; box on;
title('Phonon density of states per unique atom')
y=zeros(size(omega));
for i=1:size(dos_per_unique_atom,2)
y=y+dos_per_unique_atom(:,i)
plot(omega,y)
end
l=legend(unique_atom_labels);
set(l,'edgecolor','none','location','northwest')
set(gca,'xminortick','on','yminortick','on')
ylabel(['Phonon density of states (' dos_unit ')'])
xlabel(['Frequency (' energy_unit ')'])
outfile.dispersion_relations
This file contains a list of infile.qpoints_dispersions
) and the frequencies per mode (in the specified units via --unit
) for the corresponding points.
Row | Description |
---|---|
1 | \( q_1 \qquad \omega_1 \qquad \omega_2 \qquad \ldots \qquad \omega_{3N_a} \) |
2 | \( q_2 \qquad \omega_1 \qquad \omega_2 \qquad \ldots \qquad \omega_{3N_a} \) |
... | ... |
Not that the first column is for plotting purposes only. It serves to ensure that each line segment is scaled properly, since each segment contains a fix number of points.
outfile.group_velocities
This file contains the norm of the group velocities as a function of q. Format is identical to that of the dispersions:
Row | Description |
---|---|
1 | \( q_1 \qquad |v_1| \qquad |v_2| \qquad \ldots \qquad |v_{3N_a}| \) |
2 | \( q_2 \qquad |v_1| \qquad |v_2| \qquad \ldots \qquad |v_{3N_a}| \) |
... | ... |
The units are in km/s.
outfile.mode_gruneisen_parameters
In case you used --gruneisen
, the mode Grüneisen parameters will be written, in a format similar to the dispersions and group velocities:
Row | Description |
---|---|
1 | $ q_1 \qquad \gamma_1 \qquad \gamma_2 \qquad \ldots \qquad \gamma_{3N_a} $ |
2 | $ q_2 \qquad \gamma_1 \qquad \gamma_2 \qquad \ldots \qquad \gamma_{3N_a} $ |
... | ... |
The units are in km/s.
outfile.phonon_dos
The first column is the list of frequencies and the second column in the density of states for this frequency, given in arbitrary units. Note that integrated density of states is normalized. One can calculate partial density of states (--projected_dos_mode
); if the user specifies this option, an extra column will be added into the outfile.phonon_dos
file for each type of atom. With --projected_dos_site
the same thing happens but with an extra column for each atom in the unit cell.
Row | Description |
---|---|
1 | $ \omega_1 \qquad g(\omega_1) \qquad g_1(\omega_1) \qquad \ldots \qquad g_{N}(\omega_1) $ |
2 | $ \omega_2 \qquad g(\omega_2) \qquad g_1(\omega_2) \qquad \ldots \qquad g_{N}(\omega_2) $ |
... | ... |
The units are in states per energy unit, depending on choice of --unit
. The total DOS normalizes to 3N independent of choice of unit.
outfile.free_energy
If one chooses the option --temperature_range
or --temperature
then this file will display a list of temperatures with corresponding temperatures, vibrational free energies, vibrational entropies and heat capacities.
Row | Description |
---|---|
1 | $ T_1 \qquad F_{\textrm{vib}} \qquad S_{\textrm{vib}} \qquad C_v $ |
2 | $ T_2 \qquad F_{\textrm{vib}} \qquad S_{\textrm{vib}} \qquad C_v $ |
... | ... |
Temperature is given in K,
outfile.grid_dispersions.hdf5
Using option --dumpgrid
writes all phonon properties for a grid in the BZ to an hdf5 file, that is self-documented.
-
Born, M., & Huang, K. (1964). Dynamical theory of crystal lattices. Oxford: Oxford University Press. ↩
-
Hellman, O., Abrikosov, I. A., & Simak, S. I. (2011). Lattice dynamics of anharmonic solids from first principles. Physical Review B, 84(18), 180301. ↩
-
Hellman, O., & Abrikosov, I. A. (2013). Temperature-dependent effective third-order interatomic force constants from first principles. Physical Review B, 88(14), 144301. ↩
-
Hellman, O., Steneteg, P., Abrikosov, I. A., & Simak, S. I. (2013). Temperature dependent effective potential method for accurate free energy calculations of solids. Physical Review B, 87(10), 104111. ↩
-
Gonze, X., Charlier, J.-C., Allan, D. C. & Teter, M. P. Interatomic force constants from first principles: The case of α-quartz. Phys. Rev. B 50, 13035–13038 (1994). ↩
-
Gonze, X. & Lee, C. Dynamical matrices, Born effective charges, dielectric permittivity tensors, and interatomic force constants from density-functional perturbation theory. Phys. Rev. B 55, 10355–10368 (1997). ↩