Introduction to phonopy

Size: px
Start display at page:

Download "Introduction to phonopy"

Transcription

1 Introduction to phonopy

2 Installation Download phonopy Install Python libraries that phonopy relies Install phonopy % sudo apt-get install python-dev python-numpy \ python-matplotlib python-tk python-lxml python-yaml % tar xvfz phonopy tar.gz % cd phonopy % python setup.py install home=. Add the phonopy library directory (e.g., ~/phonopy-0.9.3/lib/python) to PYTHONPATH, maybe in.bashrc,.zshenv, etc. export PYTHONPATH=$PYTHONPATH:~/phonopy-0.9.3/lib/python

3 Run examples Suppose phonopy's /bin is in the list of the execution path. Examples are found at % cd example/si % phonopy -p % cd example/nacl % phonopy -p -nac

4 Phonopy is A phonon calculation toolbox and toolkit Easily installed on Ubuntu (or recent distributions) Currently Windows and Mac OS X are out of consideration. Windows and Mac users are encouraged to boot Ubuntu on a virtual machine (e.g. VMware, Virtualbox) Phonopy requires force calculators, e.g., it work togather with first-principles calculations, or any calculation that can calculate forces on atoms. Processes of phonopy and force calculations are completely separated. Therefore phonopy can be applied to any force calculator with small effort. Written mainly in Python Phonopy Python module is prepared.

5 Calculation steps A supercell with a displacement 1. Prepare a unit cell 2. Relax the structure 3. Build a set of supercells with displacements 4. Calculate forces on atoms of the set of supercells 5. Collect sets of forces Forces Displacement 6. Calculate phonon frequencies

6 Work flow of phonopy Prepare a crystal structure at equilibrium in VASP POSCAR format Create supercells with displacements Force calculation by a force calculator, e.g. VASP Force collection Phonon analysis Collect sets of forces on atoms of the supercells Density of states, Band structure, Thermal properties, etc. Further analysis from a set of phonon calculations Thermal expansion, etc.

7 Pre-process & Force collection Pre-process Force collection Input structure (POSCAR) DISP and vasprun.xml's Supercell size (--dim) Supercell size (--dim) % phonopy -d -dim= % phonopy -dim= \ -f ALL_vapsrun.xml_FILES (supercell size = 2x2x2) Output files - Supercell with displacements (POSCAR-*) - Displacement directions (DISP) Output file Sets of forces (FORCES) for a post-process input.

8 POSCAR NDIM tag Phonopy process SPOSCAR, POSCAR-* DISP VASP calculations VASP DFPT calculations

9 Post process A file containing sets of forces and atomic displacements (FORCES) is transformed to supercell force constants. Dynamical matrices at arbitrary q-point are built from the supercell force constants. Dynamical matrices are solved, and phonon frequency and polarization vectors are obtained. DOS, PDOS, band structure, and thermal properties at constant volume are obtained following a setting file (INPHON) and command-line options. % cat INPHON NDIM = MP = % phonopy -p -t Thermal properties are plotted.

10 Phonopy post-process POSCAR NDIM or MATDIM tag or --dim option band.yaml FORCES or FORCE_CONSTANTS PRIMITIVE_AXIS tag mesh.yaml thermal_properties.yaml total_dos.dat partial_dos.dat

11 Computing system PC Plot Ask force calculation Cluster Ask phonon analysis (via X forwarding) Work station Recent PCs are enough strong that usually PC can be Work station.

12 Tips of force calculation in VASP INCAR of phonon calculation PREC = Accurate LREAL =.FALSE. ADDGRID =.TRUE. EDIFF = 1.0e-08 Geometry optimization of unit cell Set EDIFFG = -1.0e-08 and relax as much as possible watching the recidual forces Recidual forces of ~1e-4 ev/å may be acceptable, but depends on systems. Maybe IBRION = 2; ISIF = 3 Force calculations of supercells Set IBRION = -1 i.e. no relaxation is allowed.

13 An example set of INCARs Geometry optimization PREC ENCUT IBRION ISIF NSW NELMIN EDIFF EDIFFG IALGO ISMEAR LREAL ADDGRID LWAVE LCHARG = = = = = = = = = = = = = = Accurate e e ; SIGMA = 0.1.FALSE..TRUE..FALSE..FALSE. You may need to relax several times by mv CONTCAR POSCAR. Force calculation PREC ENCUT IBRION NELMIN EDIFF IALGO ISMEAR LREAL ADDGRID LWAVE LCHARG = = = = = = = = = = = Accurate e ; SIGMA = 0.1.FALSE..TRUE..FALSE..FALSE.

14 Tips of k-point sampling mesh in electronic structure calculations Real space Reciprocal space Unit cell 2 2 supercell ½ ½

15 Brief introduction to phonon theory

16 Harmonic oscillator Harmonic potential well Spring constant Mass k m x x Equation of motion F=ma=-kx A solution is frequency V

17 1D-lattice connected with N.N. Nearest neighbor a Mass m n-1 n n+1 n+2 un-1 un un+1 un+2 Let displacement be superposition of traveling waves

18 Dispersion relation Solving equation of motion, frequency is

19 Transverse wave q Atomic modulation is orthogonal to wave vector.

20 Longitudinal wave q Atomic modulation is parallel to wave vector.

21 Interaction among atoms We don't know how far it reaches and how strong it is. Furthermore interaction is not only in pairs.

22 Potential energy expansion Hamiltonian = kinetic + potential Potential energy is expaned with respect to atomic displacements (U). (Monatomic unit cell) : Force constants (FCs) i, j, k, : Cartesian components M, N, P, : Lattice points

23 Phonon from classical mechanics Omit higher terms than 3nd order Harmonic approximation Phonon is found to diagonalize harmonic Hamiltonian: Diagonalization is needed. Multiple atoms in a unit cell are considered. Indices μνπ... are used for internal atomic labeling. This is reduced to eigenvalue problem of dynamical matrix. * M: mass, N0: number of atoms, R: positon vector Phonon frequencies are obtained as square roots of eigenvalues of the dynamical matrix.

24 Diagonalization using computer D: dynamical matrix, w: eigenvector, s: band index It is convenient for solving eigenvalue problem using computer to construct a matrix of in the form like (two atom in unit cell): eigvals, eigvecs = numpy.linalg.eigh( dynmat )

25 Eigenvector w Orthonormality Completeness *Here indices i, j run over the Catesian components and atom indices. w(qs) are eigenvectors in the output files of phonopy.

26 Imaginary mode Imaginary frequency appears when crystal structure is dynamically unstable through the imaginary mode. Sometimes it relates to phase transition, or may be used to check if virtual crystal structure is stable or not. *In phonopy output, imaginary frequency is given as negative frequency. (a>0, b<0) Normal mode coordinate

27 Supercell approach Assume interaction range is confined in supercell size. E.g., 2x2 supercell is used to calculate force constans.

28 Finite difference method Displace one atom, and measure forces on all atoms Force on an atom (Fi) Atomic displacement (Δrj)

29 Thermal properties Thermal properties are calculated from frequencies. Quantum mechanics is necessary to derive them. Helmholtz free energy Entropy Heat capacity at constant volume

30 Crystal symmetry

31 Crystal symmetry Crystal structure has to be correctly symmetrized according to the space group type. Crystal symmetry gives high quality results and reduces computational demands. CIF database may have small number of decimals e.g. 1/ VASP geometry optimization may result in breaking symmetry in hexagonal case, etc. Detailed crystal symmetry is checked by % phonopy -symmetry --tolerance=1e-8

32 Centrings of crystals In space group type names in international table, starting with F, I, C, A, and B means that crystal has centring. F: face centre I: body centre C, A, B: base centre In these cases, the conventional unit cell is 1-, 2-, or 4-fold larger than the primitive cell. Lattice parameters of the conventional and primitive cells are related by transformation matrix. (ITA2002 Sec. 5.1) *ITA: International table volume A

33 Fm3m (e.g. Silicon) Conventional unit cell to primitive cell PRIMITIVE_AXIS =

34 Brillouin zones for space groups Go to click

35 Brillouin zone of Fm3m Coordinates wrt. reciprocal primitive lattice vectors This is to be written in QI and QF tags.

36 More on phonopy

37 Running modes of phonopy Band structure Sample q-points along specified paths Mesh sampling Sample q-points on a uniform mesh Calculations of DOS, PDOS, thermal propertiesblong to this mode. List of q-points Sample q-points listed in QPOINTS file

38 Band structure mode q-point sampling paths: QI = (1) (2) QF = (3) Number of sampling paths: ND = 3 Number of sampling points in a path: NPOINTS = 51 *End points are counted. The output file is band.yaml.

39 bandplot Re-plot band structure from band.yaml by % bandplot Command options can be shown by % bandplot -h To print out frequencies in gnuplot data format % bandplot --gnuplot If you want to cut below 0, % bandplot --fmin=0

40 Mesh sampling mode Reciprocal lattice are sampled by a uniform mesh. MP = In phonopy, a mesh point samples the Γ-point when the number is odd. Optionally, the sampling mesh can be shifted with respect to grid space. MP_shift = When MP_SHIFT is 0 or 0.5, the symmetrization of the grid points is fast, which may be important when the mesh is quite dense. The output file is mesh.yaml.

41 Mesh sampling/dos n: number of calculated q-points, g: function used for broadening DOS is obtained by % phonopy --dos or % phonopy -p (without plot) (with plot) The broadening function is the Gaussian function. (Lorentzian is in the code, but no phonopy user interface is implemented. ) Smearing width is controlled by % phonopy sigma=0.1 The output file is total_dos.dat.

42 Mesh sampling/pdos Partial DOS is obtained by PDOS = 1 2, and % phonopy As well as total DOS, smearing is controlled by --sigma. With -p option, PDOS is plotted. The output files is partial_dos.dat, and reploted by % pdosplot -i , 3 6 Where numbers for -i option correspond to 1x, 1y, 1z, 2x, 2y, 2z, (numbers are atom indices.)

43 DOS/Thermal properties Helmholtz free energy, entropy, heat capacity at constant volume are calculated from phonon frequencies by % phonopy -t With -p option, the resutls are plotted. Options --tmax,--tmin,--tstep may be used together. The output file is thermal_properties.yaml. Thermal properties are re-plotted by % propplot cv (or -fe, --entropy) (--gnuplot option is dummy...)

44 Non-analytical term correction Dynamical matrix at q 0 are corrected by nonanalytical term correction. R. M. Pick et al., PRB 1, 910, (1970) *Z: Born effective charge tensor, ε: dielectric tensor At general q-points, force constants are corrected by interpolation scheme of Wang et al. (J. Phys.: Condens. Matter. 22, (2010)) % phonopy --nac Born effective charge and dielectric tensors are necessary to use this option and those are summarized in BORN file.

45 BORN file Unit conversion factor ε Z *Only Z for independent atoms have to be written. Independent atoms are found atom_mapping of output of % phonopy --symmetry These values may be obtained by VASP 5 by setting LEPSILON =.TRUE. VASP results are found in OUTCAR around: BORN EFFECTIVE CHARGES (in e, cummulative output) MACROSCOPIC STATIC DIELECTRIC TENSOR (including local field effects in DFT)

46 Quasi-harmonic approximation (QHA) QHA: Frequencies at volumes % phonopy-qha -p -s v-e.dat \ thermal_properties_yaml_of_volume1 \ thermal_properties_yaml_of_volume2 \ thermal_properties_yaml_of_volume3... The file v-e.dat contains volumes and electronic total energies U(V) of unit cells V U

47 Thermal expansion of Silicon by QHA Origin of thermal expansion is volume dependence of frequency.

48 Volume dependence of frequency of Silicon This point

49 Animation for v_sim and else For v_sim ANIME = q-point For gdis, etc, at only Γ-point Number of pictures Amplitude ANIME = Shift Band index (from the bottom)

50 Eigenvector to displacement Displaced structure along an eigenvector is created by ANIME_TYPE = POSCAR ANIME = POSCAR-001 or POSCAR-003 is the structure that we want.

51 Finite displacements Amplitude Default value is 0.01 Å. Too small value enhances error of forces. Too large value induces anharmonic contribution. Plus-minus displacement Take plus-minus as default This often also compensates residual forces. Only plus when symmetric (automatically searched from crystal symmetry) Combination of these defaults and high enough energy convergence criteria in force calculation is expected to give uniform results.

52 Books and a reference Introduction to Lattice Dynamics (Martin T. Dove) Physical Properties of Crystals (J. F. Nye) Thermodynamics of Crystals (Duane C. Wallace) Thermodynamics and an Introduction to Thermostatistics (Herbert B. Callen) Electrons and Phonons (J. M. Ziman) Principles of Quantum Mechanics (R. Shankar) From ultrasoft pseudopotentials to the projector augmented-wave method, G. Kresse, D. Joubert, PRB 59, 1758 (1999)

Materials that you may find helpful when working through this exercise

Materials that you may find helpful when working through this exercise Detailed steps illustrating how to use VASP on the Suns in Fitz 177 For use in lab: 11/10/2009 (Original file by Dr. Rachel Getman, 11/18/2007. Editted for use by Dorrell McCalman 11/09/2009.) Note on

More information

Fundamentals and applications of Density Functional Theory Astrid Marthinsen PhD candidate, Department of Materials Science and Engineering

Fundamentals and applications of Density Functional Theory Astrid Marthinsen PhD candidate, Department of Materials Science and Engineering Fundamentals and applications of Density Functional Theory Astrid Marthinsen PhD candidate, Department of Materials Science and Engineering Outline PART 1: Fundamentals of Density functional theory (DFT)

More information

Introduction to VASP (1)

Introduction to VASP (1) Introduction to VASP (1) Yun-Wen Chen http://cms.mpi.univie.ac.at/vasp/vasp/vasp.html https://www.vasp.at/ 1 What is VASP? The Vienna Ab initio Simulation Package (VASP) is a computer program for atomic

More information

Excercise : Ammonia Flipping

Excercise : Ammonia Flipping Excercise : Ammonia Flipping Rennes, 1. September 2016 Faculty of Physics, AG-CMP, University of Vienna general remarks (1) this excercise consists of 4 steps which unfold if you untar the file ammonia

More information

Phonon calculations with SCAN

Phonon calculations with SCAN Workshop on the SCAN density functional: Fundamentals, practices, and extensions Temple university, Philadelphia May 18th, 2017 Hands-on tutorial 3 Phonon calculations with SCAN Yubo Zhang and Jianwei

More information

VASP Tutorial: Dielectric properties and the Random-Phase-Approximation (RPA)

VASP Tutorial: Dielectric properties and the Random-Phase-Approximation (RPA) VASP Tutorial: Dielectric properties and the Random-Phase-Approximation (RPA) University of Vienna, Faculty of Physics and Center for Computational Materials Science, Vienna, Austria Setting up a VASP

More information

Due: since the calculation takes longer than before, we ll make it due on 02/05/2016, Friday

Due: since the calculation takes longer than before, we ll make it due on 02/05/2016, Friday Homework 3 Due: since the calculation takes longer than before, we ll make it due on 02/05/2016, Friday Email to: jqian@caltech.edu Introduction In this assignment, you will be using a commercial periodic

More information

1. Hydrogen atom in a box

1. Hydrogen atom in a box 1. Hydrogen atom in a box Recall H atom problem, V(r) = -1/r e r exact answer solved by expanding in Gaussian basis set, had to solve secular matrix involving matrix elements of basis functions place atom

More information

Avogadro with YAeHMOP Manual

Avogadro with YAeHMOP Manual Avogadro with YAeHMOP Manual Patrick Avery, Herbert Ludowieg, Jochen Autschbach, and Eva Zurek Department of Chemistry University at Buffalo Buffalo, NY 14260-3000, USA September 11, 2017 Contents 1 Installation

More information

Hands on Session III

Hands on Session III Hands on Session III Andreas EICHLER Institut für Materialphysik and Center for Computational Materials Science Universität Wien, Sensengasse 8, A-1090 Wien, Austria b-initio ienna ackage imulation G.

More information

Phonons and lattice dynamics

Phonons and lattice dynamics Chapter Phonons and lattice dynamics. Vibration modes of a cluster Consider a cluster or a molecule formed of an assembly of atoms bound due to a specific potential. First, the structure must be relaxed

More information

Lattice dynamics. Javier Junquera. Philippe Ghosez. Andrei Postnikov

Lattice dynamics. Javier Junquera. Philippe Ghosez. Andrei Postnikov Lattice dynamics Javier Junquera Philippe Ghosez Andrei Postnikov Warm up: a little bit of notation Greek characters ( ) refer to atoms within the unit cell Latin characters ( ) refer to the different

More information

Computational Material Science Part II-1: introduction. Horng-Tay Jeng ( 鄭弘泰 ) Institute of Physics, Academia Sinica

Computational Material Science Part II-1: introduction. Horng-Tay Jeng ( 鄭弘泰 ) Institute of Physics, Academia Sinica Computational Material Science Part II-1: introduction Horng-Tay Jeng ( 鄭弘泰 ) Institute of Physics, Academia Sinica Outline Introduction of Computational Material Science (CMS) Density Functional Theory

More information

Non-adiabatic Molecular Dynamics using Hefei-NAMD

Non-adiabatic Molecular Dynamics using Hefei-NAMD Non-adiabatic Molecular Dynamics using Hefei-NAMD Qijing Zheng Hefei National Laboratory for Physical Sciences at the Microscale University of Science and Technology of China Jun 10, 2018 Q.J. Zheng (HFNL

More information

Tutorial on DFPT and TD-DFPT: calculations of phonons and absorption spectra

Tutorial on DFPT and TD-DFPT: calculations of phonons and absorption spectra Tutorial on DFPT and TD-DFPT: calculations of phonons and absorption spectra Iurii Timrov SISSA Scuola Internazionale Superiore di Studi Avanzati, Trieste Italy itimrov@sissa.it Computer modelling of materials

More information

ALMA: All-scale predictive design of heat management material structures

ALMA: All-scale predictive design of heat management material structures ALMA: All-scale predictive design of heat management material structures Version Date: 2015.11.13. Last updated 2015.12.02 Purpose of this document: Definition of a data organisation that is applicable

More information

ab initio Lattice Vibrations: Calculating the Thermal Expansion Coeffcient Felix Hanke & Martin Fuchs June 30, 2009 This afternoon s plan

ab initio Lattice Vibrations: Calculating the Thermal Expansion Coeffcient Felix Hanke & Martin Fuchs June 30, 2009 This afternoon s plan ab initio Lattice Vibrations: Calculating the Thermal Expansion Coeffcient Felix Hanke & Martin Fuchs June 3, 29 This afternoon s plan introductory talk Phonons: harmonic vibrations for solids Phonons:

More information

Structure and Dynamics : An Atomic View of Materials

Structure and Dynamics : An Atomic View of Materials Structure and Dynamics : An Atomic View of Materials MARTIN T. DOVE Department ofearth Sciences University of Cambridge OXFORD UNIVERSITY PRESS Contents 1 Introduction 1 1.1 Observations 1 1.1.1 Microscopic

More information

VASP Tutorial. Nodo Lee. Ph. D. Candidate

VASP Tutorial. Nodo Lee. Ph. D. Candidate VASP Tutorial July 17, 2014 @ SCENT HPC Summer School @ GIST Nodo Lee Ph. D. Candidate Molecular Modeling Laboratory (MML) School of Materials Science and Engineering (MSE) Gwangju Institute of Science

More information

Homework 5 Computational Chemistry (CBE 60547)

Homework 5 Computational Chemistry (CBE 60547) Homework 5 Computational Chemistry (CBE 60547) Prof. William F. Schneider Due: 1 Not Ar again! As they say, there are many ways to skin a cat! You have computed the wavefunctions of Ar

More information

Classical Theory of Harmonic Crystals

Classical Theory of Harmonic Crystals Classical Theory of Harmonic Crystals HARMONIC APPROXIMATION The Hamiltonian of the crystal is expressed in terms of the kinetic energies of atoms and the potential energy. In calculating the potential

More information

Practical calculations using first-principles QM Convergence, convergence, convergence

Practical calculations using first-principles QM Convergence, convergence, convergence Practical calculations using first-principles QM Convergence, convergence, convergence Keith Refson STFC Rutherford Appleton Laboratory September 18, 2007 Results of First-Principles Simulations..........................................................

More information

MODULE 2: QUANTUM MECHANICS. Practice: Quantum ESPRESSO

MODULE 2: QUANTUM MECHANICS. Practice: Quantum ESPRESSO MODULE 2: QUANTUM MECHANICS Practice: Quantum ESPRESSO I. What is Quantum ESPRESSO? 2 DFT software PW-DFT, PP, US-PP, PAW http://www.quantum-espresso.org FREE PW-DFT, PP, PAW http://www.abinit.org FREE

More information

Phonons In The Elk Code

Phonons In The Elk Code Phonons In The Elk Code Kay Dewhurst, Sangeeta Sharma, Antonio Sanna, Hardy Gross Max-Planck-Institut für Mikrostrukturphysik, Halle If you are allowed to measure only one property of a material, make

More information

TUTORIAL 8: PHONONS, LATTICE EXPANSION, AND BAND-GAP RENORMALIZATION

TUTORIAL 8: PHONONS, LATTICE EXPANSION, AND BAND-GAP RENORMALIZATION TUTORIAL 8: PHONONS, LATTICE EXPANSION, AND BAND-GAP RENORMALIZATION 1 INVESTIGATED SYSTEM: Silicon, diamond structure Electronic and 0K properties see W. Huhn, Tutorial 2, Wednesday August 2 2 THE HARMONIC

More information

Supporting Online Material

Supporting Online Material Supporting Online Material Materials and methods The binding energy per one sulfur atom in the GB with respect to the atomic gas state of sulfur, Eb GB, is calculated as follows. Eb GB N S = Etot GB (N

More information

Algorithms for Uncertainty Quantification

Algorithms for Uncertainty Quantification Technische Universität München SS 2017 Lehrstuhl für Informatik V Dr. Tobias Neckel M. Sc. Ionuț Farcaș April 26, 2017 Algorithms for Uncertainty Quantification Tutorial 1: Python overview In this worksheet,

More information

COMPUTATIONAL TOOL. Fig. 4.1 Opening screen of w2web

COMPUTATIONAL TOOL. Fig. 4.1 Opening screen of w2web CHAPTER -4 COMPUTATIONAL TOOL Ph.D. Thesis: J. Maibam CHAPTER: 4 4.1 The WIEN2k code In this work, all the calculations presented are performed using the WIEN2k software package (Blaha et al., 2001). The

More information

34095 Montpellier, France

34095 Montpellier, France Electronic Supplementary Material (ESI) for Physical Chemistry Chemical Physics. This journal is the Owner Societies 2015 Supporting Information Positional recurrence maps: a powerful tool to de-correlate

More information

This article appeared in a journal published by Elsevier. The attached copy is furnished to the author for internal non-commercial research and

This article appeared in a journal published by Elsevier. The attached copy is furnished to the author for internal non-commercial research and This article appeared in a journal published by Elsevier. The attached copy is furnished to the author for internal non-commercial research and education use, including for instruction at the authors institution

More information

Phonon Dispersion, Interatomic Force Constants Thermodynamic Quantities

Phonon Dispersion, Interatomic Force Constants Thermodynamic Quantities Phonon Dispersion, Interatomic Force Constants Thermodynamic Quantities Umesh V. Waghmare Theoretical Sciences Unit J N C A S R Bangalore ICMR OUTLINE Vibrations and interatomic force constants (IFC) Extended

More information

Introduction to density functional perturbation theory for lattice dynamics

Introduction to density functional perturbation theory for lattice dynamics Introduction to density functional perturbation theory for lattice dynamics SISSA and DEMOCRITOS Trieste (Italy) Outline 1 Lattice dynamic of a solid: phonons Description of a solid Equations of motion

More information

Hands-on Workshop: First-principles simulations of molecules and materials: Berlin, July 13 - July 23, 2015

Hands-on Workshop: First-principles simulations of molecules and materials: Berlin, July 13 - July 23, 2015 Hands-on Workshop: First-principles simulations of molecules and materials: Berlin, July 13 - July 23, 2015 R L e y E N e x Tutorial IV: Phonons, Lattice Expansion, and Band-gap Renormalization Manuscript

More information

6.730 Physics for Solid State Applications

6.730 Physics for Solid State Applications 6.730 Physics for Solid State Applications Lecture 8: Lattice Waves in 1D Monatomic Crystals Outline Overview of Lattice Vibrations so far Models for Vibrations in Discrete 1-D Lattice Example of Nearest

More information

Phonons I - Crystal Vibrations (Kittel Ch. 4)

Phonons I - Crystal Vibrations (Kittel Ch. 4) Phonons I - Crystal Vibrations (Kittel Ch. 4) Displacements of Atoms Positions of atoms in their perfect lattice positions are given by: R 0 (n 1, n 2, n 3 ) = n 10 x + n 20 y + n 30 z For simplicity here

More information

Speed-up of ATK compared to

Speed-up of ATK compared to What s new @ Speed-up of ATK 2008.10 compared to 2008.02 System Speed-up Memory reduction Azafulleroid (molecule, 97 atoms) 1.1 15% 6x6x6 MgO (bulk, 432 atoms, Gamma point) 3.5 38% 6x6x6 MgO (k-point sampling

More information

and strong interlayer quantum confinement

and strong interlayer quantum confinement Supporting Information GeP3: A small indirect band gap 2D crystal with high carrier mobility and strong interlayer quantum confinement Yu Jing 1,3, Yandong Ma 1, Yafei Li 2, *, Thomas Heine 1,3 * 1 Wilhelm-Ostwald-Institute

More information

MP464: Solid State Physics Problem Sheet

MP464: Solid State Physics Problem Sheet MP464: Solid State Physics Problem Sheet 1 Write down primitive lattice vectors for the -dimensional rectangular lattice, with sides a and b in the x and y-directions respectively, and a face-centred rectangular

More information

The quasi-harmonic approximation (QHA)

The quasi-harmonic approximation (QHA) The quasi-harmonic approximation (QHA) M. Palumbo 19/01/2017 Trieste, Italy Limitations of the harmonic approximation E tot(r I, u I )=E tot(r I )+ I,α E tot u u Iα + 1 2 E tot Iα 2 I,α u u Iα u Iα u Jβ

More information

TUTORIAL 6: PHONONS, LATTICE EXPANSION, AND BAND-GAP RENORMALIZATION

TUTORIAL 6: PHONONS, LATTICE EXPANSION, AND BAND-GAP RENORMALIZATION Hands-On Tutorial Workshop, July 29 th 2014 TUTORIAL 6: PHONONS, LATTICE EXPANSION, AND BAND-GAP RENORMALIZATION Christian Carbogno & Manuel Schöttler Fritz-Haber-Institut der Max-Planck-Gesellschaft,

More information

A Thesis. entitled. Structural and Electronic Properties of -Al 2 X 3 (X = O, Se, Te) Disney O. Maxwell

A Thesis. entitled. Structural and Electronic Properties of -Al 2 X 3 (X = O, Se, Te) Disney O. Maxwell A Thesis entitled Structural and Electronic Properties of -Al 2 X 3 (X = O, Se, Te) by Disney O. Maxwell Submitted to the Graduate Faculty as partial fulfillment of the requirements for the Master of Science

More information

Vibrational Spectroscopy Practical 2:

Vibrational Spectroscopy Practical 2: Vibrational Spectroscopy Practical 2: The aims of today's session are to introduce you to running larger-scale CASTEP jobs on supercomputer clusters, creation of input files for and setup of CASTEP jobs,

More information

Lectures about Python, useful both for beginners and experts, can be found at (http://scipy-lectures.github.io).

Lectures about Python, useful both for beginners and experts, can be found at  (http://scipy-lectures.github.io). Random Matrix Theory (Sethna, "Entropy, Order Parameters, and Complexity", ex. 1.6, developed with Piet Brouwer) 2016, James Sethna, all rights reserved. This is an ipython notebook. This hints file is

More information

Spontaneous polarization of ferroelectric BaTiO3

Spontaneous polarization of ferroelectric BaTiO3 Spontaneous polarization of ferroelectric BaTiO3 Tutorial on how to use ATK for polarization calculations Version 2014.0 Spontaneous polarization of ferroelectric BaTiO3: Tutorial on how to use ATK for

More information

Thermodynamics of Solids: Harmonic and Quasi-harmonic Approximations

Thermodynamics of Solids: Harmonic and Quasi-harmonic Approximations Thermodynamics of Solids: Harmonic and Quasi-harmonic Approximations, USA, July 9-14, 2017 Alessandro Erba Dipartimento di Chimica, Università di Torino (Italy) alessandro.erba@unito.it 2017 Outline -

More information

Vibrational frequencies in solids: tools and tricks

Vibrational frequencies in solids: tools and tricks Vibrational frequencies in solids: tools and tricks Roberto Dovesi Gruppo di Chimica Teorica Università di Torino Torino, 4-9 September 2016 This morning 3 lectures: R. Dovesi Generalities on vibrations

More information

+ V = 0, j = 1,..., 3N (7.1) i =1, 3 m = 1, N, X mi, V X mi. i = 0 in the equilibrium. X mi X nj

+ V = 0, j = 1,..., 3N (7.1) i =1, 3 m = 1, N, X mi, V X mi. i = 0 in the equilibrium. X mi X nj 7. Lattice dynamics 7.1 Basic consideratons In this section we ll follow a number of well-known textbooks, and only try to keep the notations consistent. Suppose we have a system of N atoms, m=1,...,n,

More information

Lab 1: Handout GULP: an Empirical energy code

Lab 1: Handout GULP: an Empirical energy code Lab 1: Handout GULP: an Empirical energy code We will be using the GULP code as our energy code. GULP is a program for performing a variety of types of simulations on 3D periodic solids, gas phase clusters,

More information

Density functional theory and beyond: Computational materials science for real materials Los Angeles, July 21 August 1, 2014

Density functional theory and beyond: Computational materials science for real materials Los Angeles, July 21 August 1, 2014 Density functional theory and beyond: Computational materials science for real materials Los Angeles, July 21 August 1, 2014 R L e y E N e x Tutorial VI: Phonons, Lattice Expansion, and Band-gap Renormalization

More information

CHEM6085: Density Functional Theory

CHEM6085: Density Functional Theory Lecture 11 CHEM6085: Density Functional Theory DFT for periodic crystalline solids C.-K. Skylaris 1 Electron in a one-dimensional periodic box (in atomic units) Schrödinger equation Energy eigenvalues

More information

The Harmonic Oscillator: Zero Point Energy and Tunneling

The Harmonic Oscillator: Zero Point Energy and Tunneling The Harmonic Oscillator: Zero Point Energy and Tunneling Lecture Objectives: 1. To introduce simple harmonic oscillator model using elementary classical mechanics.. To write down the Schrodinger equation

More information

Phonon Transport in Nanostructures

Phonon Transport in Nanostructures Phonon Transport in Nanostructures David-Alexander Robinson & Pádraig Ó Conbhuí 08332461 13th December 2011 Contents 1 Introduction & Theory 1 1.1 TiO 2 Nanostructure Production...................... 1

More information

Introduction to FARGO3D

Introduction to FARGO3D Introduction to FARGO3D PABLO BENITEZ-LLAMBAY / PBLLAMBAY@NBI.KU.DK FARGO3D is a versatile HD/MHD code that runs on clusters of CPUs or GPUs, developed with special emphasis on protoplanetary disks. However,

More information

Supplementary Information: Construction of Hypothetical MOFs using a Graph Theoretical Approach. Peter G. Boyd and Tom K. Woo*

Supplementary Information: Construction of Hypothetical MOFs using a Graph Theoretical Approach. Peter G. Boyd and Tom K. Woo* Electronic Supplementary Material ESI) for CrystEngComm. This journal is The Royal Society of Chemistry 2016 Supplementary Information: Construction of Hypothetical MOFs using a Graph Theoretical Approach

More information

D I S P E R S I O N AND D A M P I N G OF SECOND SOUND IN ) Abstract

D I S P E R S I O N AND D A M P I N G OF SECOND SOUND IN ) Abstract Physics Vol. 3, No. 4. pp. 221-229, 1967. Physics Publishing Co. Printed in Great Britain. D I S P E R S I O N AND D A M P I N G OF SECOND SOUND IN N O N - I S O T R O P I C SOLIDS P H I L I P C. K WOK

More information

Geometry Optimisation

Geometry Optimisation Geometry Optimisation Matt Probert Condensed Matter Dynamics Group Department of Physics, University of York, UK http://www.cmt.york.ac.uk/cmd http://www.castep.org Motivation Overview of Talk Background

More information

Half-Heusler Alloys as Promising Thermoelectric Materials. Alexander A. Page

Half-Heusler Alloys as Promising Thermoelectric Materials. Alexander A. Page Half-Heusler Alloys as Promising Thermoelectric Materials by Alexander A. Page A dissertation submitted in partial fulfillment of the requirements for the degree of Doctor of Philosophy (Physics) in the

More information

Table of Contents. Table of Contents Converting lattices: Rhombohedral to hexagonal and back

Table of Contents. Table of Contents Converting lattices: Rhombohedral to hexagonal and back Table of Contents Table of Contents Converting lattices: Rhombohedral to hexagonal and back Conversion between hp and hr representations Converting hp supercell to hr primitive cell Crystal classifications

More information

Structural Calculations phase stability, surfaces, interfaces etc

Structural Calculations phase stability, surfaces, interfaces etc Structural Calculations phase stability, surfaces, interfaces etc Keith Refson STFC Rutherford Appleton Laboratory September 19, 2007 Phase Equilibrium 2 Energy-Volume curves..................................................................

More information

Tutorial 1. Atoms, molecules, and bulk systems. Computational Materials Physics, Faculty of Physics, University Vienna, Vienna, Austria

Tutorial 1. Atoms, molecules, and bulk systems. Computational Materials Physics, Faculty of Physics, University Vienna, Vienna, Austria Tutorial 1 Atoms, molecules, and bulk systems Computational Materials Physics, Faculty of Physics, University Vienna, Vienna, Austria I. The INCAR file II. The POSCAR file III. The KPOINTS file IV. The

More information

The Plane-wave Pseudopotential Method

The Plane-wave Pseudopotential Method The Plane-wave Pseudopotential Method k(r) = X G c k,g e i(g+k) r Chris J Pickard Electrons in a Solid Nearly Free Electrons Nearly Free Electrons Nearly Free Electrons Electronic Structures Methods Empirical

More information

Supplementary Figures

Supplementary Figures Supplementary Figures 8 6 Energy (ev 4 2 2 4 Γ M K Γ Supplementary Figure : Energy bands of antimonene along a high-symmetry path in the Brillouin zone, including spin-orbit coupling effects. Empty circles

More information

Supporting Information

Supporting Information Supporting Information The Origin of Active Oxygen in a Ternary CuO x /Co 3 O 4 -CeO Catalyst for CO Oxidation Zhigang Liu, *, Zili Wu, *, Xihong Peng, ++ Andrew Binder, Songhai Chai, Sheng Dai *,, School

More information

6.730 Physics for Solid State Applications

6.730 Physics for Solid State Applications 6.730 Physics for Solid State Applications Lecture 5: Specific Heat of Lattice Waves Outline Review Lecture 4 3-D Elastic Continuum 3-D Lattice Waves Lattice Density of Modes Specific Heat of Lattice Specific

More information

Homework 2: Structure and Defects in Crystalline and Amorphous Materials

Homework 2: Structure and Defects in Crystalline and Amorphous Materials Homework 2: Structure and Defects in Crystalline and Amorphous Materials Muhammad Ashraful Alam Network of Computational Nanotechnology Discovery Park, Purdue University. In Lectures 4-6, we have discussed

More information

VASP: Dielectric response Perturbation theory, linear response, and finite electric fields

VASP: Dielectric response Perturbation theory, linear response, and finite electric fields VASP: Dielectric response Perturbation theory, linear response, and finite electric fields University of Vienna, Faculty of Physics and Center for Computational Materials Science, Vienna, Austria Outline

More information

Physics with Matlab and Mathematica Exercise #1 28 Aug 2012

Physics with Matlab and Mathematica Exercise #1 28 Aug 2012 Physics with Matlab and Mathematica Exercise #1 28 Aug 2012 You can work this exercise in either matlab or mathematica. Your choice. A simple harmonic oscillator is constructed from a mass m and a spring

More information

Key concepts in Density Functional Theory (II)

Key concepts in Density Functional Theory (II) Kohn-Sham scheme and band structures European Theoretical Spectroscopy Facility (ETSF) CNRS - Laboratoire des Solides Irradiés Ecole Polytechnique, Palaiseau - France Present Address: LPMCN Université

More information

Defects in TiO 2 Crystals

Defects in TiO 2 Crystals , March 13-15, 2013, Hong Kong Defects in TiO 2 Crystals Richard Rivera, Arvids Stashans 1 Abstract-TiO 2 crystals, anatase and rutile, have been studied using Density Functional Theory (DFT) and the Generalized

More information

Problem Set 2: First-Principles Energy Methods

Problem Set 2: First-Principles Energy Methods Problem Set 2: First-Principles Energy Methods Problem 1 (10 points): Convergence of absolute energies with respect to cutoff energies. A Using the Quantum ESPRESSO PWscf package, calculate the energy

More information

SnO 2 Physical and Chemical Properties due to the Impurity Doping

SnO 2 Physical and Chemical Properties due to the Impurity Doping , March 13-15, 2013, Hong Kong SnO 2 Physical and Chemical Properties due to the Impurity Doping Richard Rivera, Freddy Marcillo, Washington Chamba, Patricio Puchaicela, Arvids Stashans Abstract First-principles

More information

Quantum Theory of Matter

Quantum Theory of Matter Imperial College London Department of Physics Professor Ortwin Hess o.hess@imperial.ac.uk Quantum Theory of Matter Spring 014 1 Periodic Structures 1.1 Direct and Reciprocal Lattice (a) Show that the reciprocal

More information

Band Structure Calculations; Electronic and Optical Properties

Band Structure Calculations; Electronic and Optical Properties ; Electronic and Optical Properties Stewart Clark University of Outline Introduction to band structures Calculating band structures using Castep Calculating optical properties Examples results Some applications

More information

1 Bulk Simulations in a HCP lattice

1 Bulk Simulations in a HCP lattice 1 Bulk Simulations in a HCP lattice 1.1 Introduction This project is a continuation of two previous projects that studied the mechanism of melting in a FCC and BCC lattice. The current project studies

More information

Accuracy and transferability of GAP models for tungsten

Accuracy and transferability of GAP models for tungsten Accuracy and transferability of GAP models for tungsten Wojciech J. Szlachta Albert P. Bartók Gábor Csányi Engineering Laboratory University of Cambridge 5 November 214 Motivation Number of atoms 1 1 2

More information

QuantumWise. QuantumWise is now part of Synopsys

QuantumWise. QuantumWise is now part of Synopsys Table of Contents Table of Contents NiSi2 Si interface Create the NiSi2/Si device The screening region Increase the length of the central region Set-up the calculation for the undoped device Dope the device

More information

PROJECT C: ELECTRONIC BAND STRUCTURE IN A MODEL SEMICONDUCTOR

PROJECT C: ELECTRONIC BAND STRUCTURE IN A MODEL SEMICONDUCTOR PROJECT C: ELECTRONIC BAND STRUCTURE IN A MODEL SEMICONDUCTOR The aim of this project is to present the student with a perspective on the notion of electronic energy band structures and energy band gaps

More information

Electrons in a weak periodic potential

Electrons in a weak periodic potential Electrons in a weak periodic potential Assumptions: 1. Static defect-free lattice perfectly periodic potential. 2. Weak potential perturbative effect on the free electron states. Perfect periodicity of

More information

DOING PHYSICS WITH MATLAB WAVE MOTION

DOING PHYSICS WITH MATLAB WAVE MOTION DOING PHYSICS WITH MATLAB WAVE MOTION THE [1D] SCALAR WAVE EQUATION THE FINITE DIFFERENCE TIME DOMAIN METHOD Ian Cooper School of Physics, University of Sydney ian.cooper@sydney.edu.au DOWNLOAD DIRECTORY

More information

PHY 123 Lab 9 Simple Harmonic Motion

PHY 123 Lab 9 Simple Harmonic Motion PHY 123 Lab 9 Simple Harmonic Motion (updated 11/17/16) The purpose of this lab is to study simple harmonic motion of a system consisting of a mass attached to a spring. You will establish the relationship

More information

Electronic Structure Methodology 1

Electronic Structure Methodology 1 Electronic Structure Methodology 1 Chris J. Pickard Lecture Two Working with Density Functional Theory In the last lecture we learnt how to write the total energy as a functional of the density n(r): E

More information

Electronic Structure Theory for Periodic Systems: The Concepts. Christian Ratsch

Electronic Structure Theory for Periodic Systems: The Concepts. Christian Ratsch Electronic Structure Theory for Periodic Systems: The Concepts Christian Ratsch Institute for Pure and Applied Mathematics and Department of Mathematics, UCLA Motivation There are 10 20 atoms in 1 mm 3

More information

Crystal Relaxation, Elasticity, and Lattice Dynamics

Crystal Relaxation, Elasticity, and Lattice Dynamics http://exciting-code.org Crystal Relaxation, Elasticity, and Lattice Dynamics Pasquale Pavone Humboldt-Universität zu Berlin http://exciting-code.org PART I: Structure Optimization Pasquale Pavone Humboldt-Universität

More information

Appendix D Simulating Spectroscopic Bands Using Gaussian and PGopher

Appendix D Simulating Spectroscopic Bands Using Gaussian and PGopher 429 Appendix D Simulating Spectroscopic Bands Using Gaussian and PGopher This appendix contains methods for using Gaussian 09 121 and PGopher 120 to simulate vibrational and electronic bands of molecules.

More information

Electronic structure calculations with GPAW. Jussi Enkovaara CSC IT Center for Science, Finland

Electronic structure calculations with GPAW. Jussi Enkovaara CSC IT Center for Science, Finland Electronic structure calculations with GPAW Jussi Enkovaara CSC IT Center for Science, Finland Basics of density-functional theory Density-functional theory Many-body Schrödinger equation Can be solved

More information

PHY 123 Lab 10-Simple Harmonic Motion

PHY 123 Lab 10-Simple Harmonic Motion 1 To print higher-resolution math symbols, click the Hi-Res Fonts for Printing button on the jsmath control panel. PHY 123 Lab 10-Simple Harmonic Motion The purpose of this lab is to study simple harmonic

More information

Chapter 3. The (L)APW+lo Method. 3.1 Choosing A Basis Set

Chapter 3. The (L)APW+lo Method. 3.1 Choosing A Basis Set Chapter 3 The (L)APW+lo Method 3.1 Choosing A Basis Set The Kohn-Sham equations (Eq. (2.17)) provide a formulation of how to practically find a solution to the Hohenberg-Kohn functional (Eq. (2.15)). Nevertheless

More information

DMDW: A set of tools to calculate Debye-Waller factors and other related quantities using dynamical matrices.

DMDW: A set of tools to calculate Debye-Waller factors and other related quantities using dynamical matrices. DMDW: A set of tools to calculate Debye-Waller factors and other related quantities using dynamical matrices. DMDW is a set of tools developed to calculate Debye-Waller (DW) factors and other related quantities

More information

MP464: Solid State Physics Problem Sheet

MP464: Solid State Physics Problem Sheet MP464: Solid State Physics Problem Sheet 1) Write down primitive lattice vectors for the -dimensional rectangular lattice, with sides a and b in the x and y-directions respectively, and a face-centred

More information

MENA 9520 FME Modelling Tutorial 5 ( )

MENA 9520 FME Modelling Tutorial 5 ( ) MENA 9520 FME Modelling Tutorial 5 (25.02.2011) Task 5: Understanding type of bonding using charge-density plots Exercise 5.1: Visualizing charge density in Si: 1. mkdir charge 2. Copy a converged CTRL

More information

Dig In to the Real World with the TI-84 Plus CE

Dig In to the Real World with the TI-84 Plus CE Dig In to the Real World with the TI-84 Plus CE 7th Annual T International Conference Fort Worth, Texas Friday, March 1, 015 10:00 a.m. 11:0 a.m. Omni Hotel, Texas Ballroom H John LaMaster, National T³

More information

Introduction to solid state physics

Introduction to solid state physics PHYS 342/555 Introduction to solid state physics Instructor: Dr. Pengcheng Dai Professor of Physics The University of Tennessee (Room 407A, Nielsen, 974-1509) Chapter 5: Thermal properties Lecture in pdf

More information

Roger Johnson Structure and Dynamics: Displacive phase transition Lecture 9

Roger Johnson Structure and Dynamics: Displacive phase transition Lecture 9 9.1. Summary In this Lecture we will consider structural phase transitions characterised by atomic displacements, which result in a low temperature structure that is distorted compared to a higher temperature,

More information

IAP 2006: From nano to macro: Introduction to atomistic modeling techniques and application in a case study of modeling fracture of copper (1.

IAP 2006: From nano to macro: Introduction to atomistic modeling techniques and application in a case study of modeling fracture of copper (1. IAP 2006: From nano to macro: Introduction to atomistic modeling techniques and application in a case study of modeling fracture of copper (1.978 PDF) http://web.mit.edu/mbuehler/www/teaching/iap2006/intro.htm

More information

Chemistry 365: Normal Mode Analysis David Ronis McGill University

Chemistry 365: Normal Mode Analysis David Ronis McGill University Chemistry 365: Normal Mode Analysis David Ronis McGill University 1. Quantum Mechanical Treatment Our starting point is the Schrodinger wave equation: Σ h 2 2 2m i N i=1 r 2 i + U( r 1,..., r N ) Ψ( r

More information

arxiv: v1 [cond-mat.mtrl-sci] 11 Aug 2017

arxiv: v1 [cond-mat.mtrl-sci] 11 Aug 2017 DynaPhoPy: code for extracting phonon quasiparticles from molecular dynamics simulations bel Carreras a,, tsushi Togo b, Isao Tanaka a,b a Department of Materials Science and Engineering, Kyoto University,

More information

Structural and Electronic Effects on the Properties of Fe 2 (dobdc) upon Oxidation with N 2 O

Structural and Electronic Effects on the Properties of Fe 2 (dobdc) upon Oxidation with N 2 O Supporting information for paper in Inorganic Chemistry, April 11, 016, page S-1 Structural and Electronic Effects on the Properties of Fe (dobdc) upon Oxidation with N O oshua Borycz, 1, oachim Paier,

More information

Numerical Calculation of Density of States and Band Structure

Numerical Calculation of Density of States and Band Structure Numerical Calculation of Density of States and Band Structure A Thesis Submitted in Partial Satisfaction Of the Requirements for the Degree of Bachelor of Science in Physics at the University of California,

More information

A Thesis. entitled. Calculations. Sankeerth Rajalingam. Submitted to the Graduate Faculty as partial fulfillment of the requirements for the

A Thesis. entitled. Calculations. Sankeerth Rajalingam. Submitted to the Graduate Faculty as partial fulfillment of the requirements for the A Thesis entitled Theoretical Investigations of -Ga 2 O 3, -Ga 2 Se 3 and -Ga 2 Te 3 Using Ab-Initio Calculations by Sankeerth Rajalingam Submitted to the Graduate Faculty as partial fulfillment of the

More information

Supporting Information

Supporting Information Electronic Supplementary Material (ESI) for Nanoscale. This journal is The Royal Society of Chemistry 2015 Supporting Information Single Layer Lead Iodide: Computational Exploration of Structural, Electronic

More information