Solving Many-Body Schrödinger Equation Using Density Functional Theory and Finite Elements

Size: px
Start display at page:

Download "Solving Many-Body Schrödinger Equation Using Density Functional Theory and Finite Elements"

Transcription

1 Solving Many-Body Schrödinger Equation Using Density Functional Theory and Finite Elements Institute of Physics, Academy of Sciences of the Czech Republic June 21, 2008

2 Introduction Contens Density Functional Theory Spherically symmetric problems, examples Mixing schemes Non symmetric 3D problems, Finite Element Method

3 Schrödinger equation where Ĥ Ψ = ( ˆT + Û + ˆV ) Ψ = E Ψ Û = i<j ˆT = N i i U(r i, r j ) = 1 U(r i, r j ) 2 U(r i, r j ) = U(r j, r i ) = ˆV = i,j N v(r i ) i 1 r i r j v(r i ) = k Z k r i R k

4 Density Functional Theory We solve the Kohn-Sham equations: ( V H (r) + V xc (r) + v(r))ψ i (r) = ɛ i ψ(r) that yield the orbitals ψ i that reproduce the density n(r) of the original interacting system n(r) = V H (r) = δe H δn(r) = 1 2 N ψ i (r) 2 i n(r ) r r d3 r 2 V H = n(r) E xc [n] = (T + U)[n] E H [n] T S [n] V xc (r) = δe xc[n] δn(r) v(r) = k Z k r R k

5 Atomic wavefunctions Spherically symmetric potential: Radial Schrödinger equation: V (x) = V (r) ψ nlm (x) = R nl (r) Y lm ( x r R nl + 2 r R nl + 2M 2 (E V )R l(l + 1) nl r 2 R nl = 0 )

6 Relativistic atomic wavefunctions Dirac equation: (icγ µ D µ mc 2 )ψ = 0 D µ = µ + iea µ Radial Dirac equation: ( ) [ 2 (E g κ + g κ+ ) κ(κ + 1) V r + V 2Mc 2 Radial Schrödinger equation: R + 2 r R + f κ = g κ 2Mc + κ + 1 g κ r 2Mc R 2 = f 2 + g 2 [ (E V ) 2Mr 2 + κ + 1 4M 2 c 2 r V ] l(l + 1) 2Mr 2 2MR = 0 ] 2Mg κ = 0

7 Code (300 lines in Python, 800 in Fortran) from atom import atom, show import radial import utils def do(z): R = radial.create_log_grid(z) s = atom(z,alpha=0.3,iter=20,relat=0,grid=r) n5_lda = radial.ks_construct_density(s,r,z)*r*r s = atom(z,alpha=0.3,iter=20,relat=2,grid=r) n5_rlda = radial.ks_construct_density(s,r,z)*r*r utils.makeplot(r,[ (n5_lda,"b-","non-relativistic"), (n5_rlda,"g-","full relativistic"), ],title="z=%d"%(z),xleg="r", yleg="radial density * R^2") do(5) #do(82)

8 Boron

9 Lead

10 Lead - nonrelativistic calculation Iterations: 20 F (x) = Agrees with NIST: 1s( 2): s( 2): p( 6): s( 2): p( 6): d(10): s( 2): p( 6): d(10): f(14): s( 2): p( 6): d(10): s( 2): p( 2):

11 Lead - relativistic calculation Iterations: 20 F (x) = s( 2) j=l+1/2: s( 2) j=l+1/2: p( 6) j=l-1/2: p( 6) j=l+1/2: s( 2) j=l+1/2: p( 6) j=l-1/2: p( 6) j=l+1/2: d(10) j=l-1/2: d(10) j=l+1/2: s( 2) j=l+1/2: p( 6) j=l-1/2: p( 6) j=l+1/2: d(10) j=l-1/2: d(10) j=l+1/2: s( 2) j=l+1/2: f(14) j=l-1/2: f(14) j=l+1/2: p( 6) j=l-1/2: p( 6) j=l+1/2: d(10) j=l-1/2: d(10) j=l+1/2: s( 2) j=l+1/2: p( 2) j=l-1/2:

12 Iteration to self-consistency The problem: F(x) = x equivalently R(x) = 0 for R(x) = F(x) x. We approximate R(x M+1 ) R(x M ) J (x M+1 x M ) with the Jacobian We want R(x M+1 ) = 0: J ij = R i x j x M+1 x M J 1 R(x M ) J is approximated by a sequence of J 0, J 1, J 2,...

13 Linear mixing with so x M+1 x M J 1 M R(x M) J 1 M = α1 x M+1 = x M + αr(x M ) = x M + α(f(x M ) x M ) SciPy from scipy.optimize.nonlin import linearmixing

14 exciting mixing Used in the FP-LAPW DFT code ( with x M+1 x M J 1 M R(x M) J 1 M = diag(β 1, β 2, β 3,... ) start with β 1 = β 2 = β 3 = = α and at every iteration adjust the parameters β i according to this very simple algorithm: if R i (x M 1 )R i (x M ) > 0 then increase β i by α otherwise set β i = α (if β i > α max, set β i = α max ). SciPy from scipy.optimize.nonlin import excitingmixing

15 Broyden update The first Broyden method: J M+1 = J M ( R(x M) + J M x M ) x T M x M 2 The second Broyden method: J 1 M+1 = J 1 M + ( x M J 1 M starting with the linear mixing: J 1 0 = α1 R(x M)) R(x M ) T R(x M ) 2 SciPy from scipy.optimize import broyden1, broyden2

16 low memory second Broyden update The second Broyden method (J 1 M+1 = J 1 M with + ( x M J 1 M R(x M)) R(x M ) T R(x M ) 2 J 1 M+1 = J 1 M + uvt u = x M J 1 M R(x M) v = R(x M) R(x M ) 2 so the whole inverse Jacobian can be written as ) can be written as J 1 M = α1 + u 1v T 1 + u 2 v T 2 + u 3 v T 3 + J 1 M y = αy + u 1(v T 1 y) + u 2 (v T 2 y) + u 3 (v T 3 y) + SciPy from scipy.optimize import broyden3

17 Other methods The generalized Broyden method (modified Broyden method): M 1 p=m k (1 + ω 2 0δ pn ) R(x n ) T R(x p )γ p = R(x n ) T R(x M ) x M+1 = x M + β M R(x M ) M 1 p=m k other methods: Anderson, extended Anderson γ p ( x p + β M R(x p )) SciPy from scipy.optimize import broyden generalized, anderson, anderson2

18 Finite element formulation One particle Schrödinger equation: ) ( 2 2m 2 + V ψ = Eψ. FEM: (K ij + V ij ) q j = EM ij q j + F i, V ij = φ i V φ j dv, M ij = φ i φ j dv, K ij = 2 φ i φ j dv, 2m F i = 2 2m dψ dn φ i ds. Usually we set F i = 0.

19 SfePy SfePy = general finite element analysis software BSD open-source license available at (developers) mailing lists, issue (bug) tracking we encourage and support everyone who joins! (project information) selected applications: homogenization of porous media (parallel flows in a deformable porous medium) acoustic band gaps (homogenization of a strongly heterogenous elastic structure: phononic materials) shape optimization in incompressible flow problems

20 Particle in the box V (x) = Analytic solution: { 0, inside the box a a a, outside E n1 n 2 n 3 = π2 ( n 2 2a n2 2 + n3 2 ) where n i = 1, 2, 3,... are independent quantum numbers. We chose a = 1, i.e.: E 111 = , E 211 = E 121 = E 112 = , E 122 = E 212 = E 221 = , E 311 = E 131 = E 113 = E 222 = , E 123 = Eperm. = Numerical solution (a = 1, nodes): E theory FEM

21 3D Harmonic oscillator V (r) = { 1 2 ω2 r 2, inside the box a a a, outside Analytic solution in the limit a : ( E nl = 2n + l + 3 ) ω 2 where n, l = 0, 1, 2,.... Degeneracy is 2l + 1, so: E 00 = 3 2, triple E 01 = 5 2, E 10 = 7 2, quintuple E 02 = 7 2 triple E 11 = 9 2, quintuple E 12 = 11 2 : Numerical solution (a = 15, ω = 1, nodes): E theory FEM

22 3D Harmonic oscillator Eigenvectors: 0th 12th 10th 12th

23 Hydrogen atom V (r) = Analytic solution in the limit a : { 1 r, inside the box a a a, outside E n = 1 2n 2 where n = 1, 2, 3,.... Degeneracy is n 2, so: E 1 = 1 2 = 0.5, E 2 = 1 8 = 0.125, E 3 = 1 18 = 0.055, E 4 = 1 32 = Numerical solution (a = 15, nodes): E theory FEM

24 Hydrogen atom 11th eigenvalue (calculated: , exact: ), on the mesh with tetrahedrons and nodes, for the hydrogen atom (V=-1/r).

25 FEM+DFT We solve the Kohn-Sham equations using FEM: ( V H (r) + V xc (r) + v(r))ψ i (r) = ɛ i ψ(r) that yield the orbitals ψ i that reproduce the density n(r) of the original interacting system n(r) = N ψ i (r) 2 i 2 V H = n(r) v(r) = k Z k r R k

26 Boron Current status (uniform tetrahedral mesh, nodes): radial FEM Bad convergence should greatly improve with a better mesh 2th eigenvector (contours and a slice), 3th eigenvector (slice)

27 Conclusion, Future work automatic mesh generation and refining use pseudopotentials (reduces the number of electrons to solve for) only depend on open source (free software) solutions Acknowledgements This research was partly supported by the LC06040 research center project and the GACR grant no. IAA

(Multiscale) Modelling With SfePy

(Multiscale) Modelling With SfePy (Multiscale) Modelling With SfePy Random Remarks... Robert Cimrman & Eduard Rohan & others Department of Mechanics & New Technologies Research Centre University of West Bohemia Plzeň, Czech Republic PANM

More information

ONE AND MANY ELECTRON ATOMS Chapter 15

ONE AND MANY ELECTRON ATOMS Chapter 15 See Week 8 lecture notes. This is exactly the same as the Hamiltonian for nonrigid rotation. In Week 8 lecture notes it was shown that this is the operator for Lˆ 2, the square of the angular momentum.

More information

DFT in practice : Part II. Ersen Mete

DFT in practice : Part II. Ersen Mete pseudopotentials Department of Physics Balıkesir University, Balıkesir - Turkey August 13, 2009 - NanoDFT 09, İzmir Institute of Technology, İzmir Outline Pseudopotentials Basic Ideas Norm-conserving pseudopotentials

More information

Ch 125a Problem Set 1

Ch 125a Problem Set 1 Ch 5a Problem Set Due Monday, Oct 5, 05, am Problem : Bra-ket notation (Dirac notation) Bra-ket notation is a standard and convenient way to describe quantum state vectors For example, φ is an abstract

More information

1 r 2 sin 2 θ. This must be the case as we can see by the following argument + L2

1 r 2 sin 2 θ. This must be the case as we can see by the following argument + L2 PHYS 4 3. The momentum operator in three dimensions is p = i Therefore the momentum-squared operator is [ p 2 = 2 2 = 2 r 2 ) + r 2 r r r 2 sin θ We notice that this can be written as sin θ ) + θ θ r 2

More information

The Hydrogen Atom. Chapter 18. P. J. Grandinetti. Nov 6, Chem P. J. Grandinetti (Chem. 4300) The Hydrogen Atom Nov 6, / 41

The Hydrogen Atom. Chapter 18. P. J. Grandinetti. Nov 6, Chem P. J. Grandinetti (Chem. 4300) The Hydrogen Atom Nov 6, / 41 The Hydrogen Atom Chapter 18 P. J. Grandinetti Chem. 4300 Nov 6, 2017 P. J. Grandinetti (Chem. 4300) The Hydrogen Atom Nov 6, 2017 1 / 41 The Hydrogen Atom Hydrogen atom is simplest atomic system where

More information

Quantum Mechanics Solutions

Quantum Mechanics Solutions Quantum Mechanics Solutions (a (i f A and B are Hermitian, since (AB = B A = BA, operator AB is Hermitian if and only if A and B commute So, we know that [A,B] = 0, which means that the Hilbert space H

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

Schrödinger equation for the nuclear potential

Schrödinger equation for the nuclear potential Schrödinger equation for the nuclear potential Introduction to Nuclear Science Simon Fraser University Spring 2011 NUCS 342 January 24, 2011 NUCS 342 (Lecture 4) January 24, 2011 1 / 32 Outline 1 One-dimensional

More information

Lecture 3. Solving the Non-Relativistic Schroedinger Equation for a spherically symmetric potential

Lecture 3. Solving the Non-Relativistic Schroedinger Equation for a spherically symmetric potential Lecture 3 Last lecture we were in the middle of deriving the energies of the bound states of the Λ in the nucleus. We will continue with solving the non-relativistic Schroedinger equation for a spherically

More information

All electron optimized effective potential method for solids

All electron optimized effective potential method for solids All electron optimized effective potential method for solids Institut für Theoretische Physik Freie Universität Berlin, Germany and Fritz Haber Institute of the Max Planck Society, Berlin, Germany. 22

More information

Pseudopotentials for hybrid density functionals and SCAN

Pseudopotentials for hybrid density functionals and SCAN Pseudopotentials for hybrid density functionals and SCAN Jing Yang, Liang Z. Tan, Julian Gebhardt, and Andrew M. Rappe Department of Chemistry University of Pennsylvania Why do we need pseudopotentials?

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

On the adaptive finite element analysis of the Kohn-Sham equations

On the adaptive finite element analysis of the Kohn-Sham equations On the adaptive finite element analysis of the Kohn-Sham equations Denis Davydov, Toby Young, Paul Steinmann Denis Davydov, LTM, Erlangen, Germany August 2015 Denis Davydov, LTM, Erlangen, Germany College

More information

Linear response time-dependent density functional theory

Linear response time-dependent density functional theory Linear response time-dependent density functional theory Emmanuel Fromager Laboratoire de Chimie Quantique, Université de Strasbourg, France fromagere@unistra.fr Emmanuel Fromager (UdS) Cours RFCT, Strasbourg,

More information

PHYS852 Quantum Mechanics II, Spring 2010 HOMEWORK ASSIGNMENT 8: Solutions. Topics covered: hydrogen fine structure

PHYS852 Quantum Mechanics II, Spring 2010 HOMEWORK ASSIGNMENT 8: Solutions. Topics covered: hydrogen fine structure PHYS85 Quantum Mechanics II, Spring HOMEWORK ASSIGNMENT 8: Solutions Topics covered: hydrogen fine structure. [ pts] Let the Hamiltonian H depend on the parameter λ, so that H = H(λ). The eigenstates and

More information

Chemistry 532 Practice Final Exam Fall 2012 Solutions

Chemistry 532 Practice Final Exam Fall 2012 Solutions Chemistry 53 Practice Final Exam Fall Solutions x e ax dx π a 3/ ; π sin 3 xdx 4 3 π cos nx dx π; sin θ cos θ + K x n e ax dx n! a n+ ; r r r r ˆL h r ˆL z h i φ ˆL x i hsin φ + cot θ cos φ θ φ ) ˆLy i

More information

Pseudopotential generation and test by the ld1.x atomic code: an introduction

Pseudopotential generation and test by the ld1.x atomic code: an introduction and test by the ld1.x atomic code: an introduction SISSA and DEMOCRITOS Trieste (Italy) Outline 1 2 3 Spherical symmetry - I The Kohn and Sham (KS) equation is (in atomic units): [ 1 ] 2 2 + V ext (r)

More information

UNIVERSITY OF MARYLAND Department of Physics College Park, Maryland. PHYSICS Ph.D. QUALIFYING EXAMINATION PART II

UNIVERSITY OF MARYLAND Department of Physics College Park, Maryland. PHYSICS Ph.D. QUALIFYING EXAMINATION PART II UNIVERSITY OF MARYLAND Department of Physics College Park, Maryland PHYSICS Ph.D. QUALIFYING EXAMINATION PART II January 22, 2016 9:00 a.m. 1:00 p.m. Do any four problems. Each problem is worth 25 points.

More information

Electronic structure, plane waves and pseudopotentials

Electronic structure, plane waves and pseudopotentials Electronic structure, plane waves and pseudopotentials P.J. Hasnip Spectroscopy Workshop 2009 We want to be able to predict what electrons and nuclei will do from first principles, without needing to know

More information

Introduction to Quantum Mechanics PVK - Solutions. Nicolas Lanzetti

Introduction to Quantum Mechanics PVK - Solutions. Nicolas Lanzetti Introduction to Quantum Mechanics PVK - Solutions Nicolas Lanzetti lnicolas@student.ethz.ch 1 Contents 1 The Wave Function and the Schrödinger Equation 3 1.1 Quick Checks......................................

More information

Fine structure in hydrogen - relativistic effects

Fine structure in hydrogen - relativistic effects LNPhysiqueAtomique016 Fine structure in hydrogen - relativistic effects Electron spin ; relativistic effects In a spectrum from H (or from an alkali), one finds that spectral lines appears in pairs. take

More information

Workshop on: ATOMIC STRUCTURE AND TRANSITIONS: THEORY IN USING SUPERSTRUCTURE PROGRAM

Workshop on: ATOMIC STRUCTURE AND TRANSITIONS: THEORY IN USING SUPERSTRUCTURE PROGRAM Workshop on: ATOMIC STRUCTURE AND TRANSITIONS: THEORY IN USING SUPERSTRUCTURE PROGRAM PROF. SULTANA N. NAHAR Astronomy, Ohio State U, Columbus, Ohio, USA Email: nahar.1@osu.edu http://www.astronomy.ohio-state.edu/

More information

Mathematical Tripos Part IB Michaelmas Term Example Sheet 1. Values of some physical constants are given on the supplementary sheet

Mathematical Tripos Part IB Michaelmas Term Example Sheet 1. Values of some physical constants are given on the supplementary sheet Mathematical Tripos Part IB Michaelmas Term 2015 Quantum Mechanics Dr. J.M. Evans Example Sheet 1 Values of some physical constants are given on the supplementary sheet 1. Whenasampleofpotassiumisilluminatedwithlightofwavelength3

More information

5.111 Lecture Summary #6

5.111 Lecture Summary #6 5.111 Lecture Summary #6 Readings for today: Section 1.9 (1.8 in 3 rd ed) Atomic Orbitals. Read for Lecture #7: Section 1.10 (1.9 in 3 rd ed) Electron Spin, Section 1.11 (1.10 in 3 rd ed) The Electronic

More information

Schrödinger equation for central potentials

Schrödinger equation for central potentials Chapter 2 Schrödinger equation for central potentials In this chapter we will extend the concepts and methods introduced in the previous chapter for a one-dimensional problem to a specific and very important

More information

Lecture 8: Radial Distribution Function, Electron Spin, Helium Atom

Lecture 8: Radial Distribution Function, Electron Spin, Helium Atom Lecture 8: Radial Distribution Function, Electron Spin, Helium Atom Radial Distribution Function The interpretation of the square of the wavefunction is the probability density at r, θ, φ. This function

More information

Quantum Mechanics in 3-Dimensions

Quantum Mechanics in 3-Dimensions Quantum Mechanics in 3-Dimensions Pavithran S Iyer, 2nd yr BSc Physics, Chennai Mathematical Institute Email: pavithra@cmi.ac.in August 28 th, 2009 1 Schrodinger equation in Spherical Coordinates 1.1 Transforming

More information

2.4. Quantum Mechanical description of hydrogen atom

2.4. Quantum Mechanical description of hydrogen atom 2.4. Quantum Mechanical description of hydrogen atom Atomic units Quantity Atomic unit SI Conversion Ang. mom. h [J s] h = 1, 05459 10 34 Js Mass m e [kg] m e = 9, 1094 10 31 kg Charge e [C] e = 1, 6022

More information

Lecture 4 Quantum mechanics in more than one-dimension

Lecture 4 Quantum mechanics in more than one-dimension Lecture 4 Quantum mechanics in more than one-dimension Background Previously, we have addressed quantum mechanics of 1d systems and explored bound and unbound (scattering) states. Although general concepts

More information

The 3 dimensional Schrödinger Equation

The 3 dimensional Schrödinger Equation Chapter 6 The 3 dimensional Schrödinger Equation 6.1 Angular Momentum To study how angular momentum is represented in quantum mechanics we start by reviewing the classical vector of orbital angular momentum

More information

Topics Covered: Motion in a central potential, spherical harmonic oscillator, hydrogen atom, orbital electric and magnetic dipole moments

Topics Covered: Motion in a central potential, spherical harmonic oscillator, hydrogen atom, orbital electric and magnetic dipole moments PHYS85 Quantum Mechanics I, Fall 9 HOMEWORK ASSIGNMENT Topics Covered: Motion in a central potential, spherical harmonic oscillator, hydrogen atom, orbital electric and magnetic dipole moments. [ pts]

More information

Key concepts in Density Functional Theory (I) Silvana Botti

Key concepts in Density Functional Theory (I) Silvana Botti From the many body problem to the Kohn-Sham scheme European Theoretical Spectroscopy Facility (ETSF) CNRS - Laboratoire des Solides Irradiés Ecole Polytechnique, Palaiseau - France Temporary Address: Centre

More information

1.2 Rare earth atoms H Ψ=E Ψ, (1.2.1) where the non-relativistic Hamiltonian operator is. H = h2 2m. v ext (r i ) (1.2.

1.2 Rare earth atoms H Ψ=E Ψ, (1.2.1) where the non-relativistic Hamiltonian operator is. H = h2 2m. v ext (r i ) (1.2. 8 1. ELEMENTS OF RARE EARTH MAGNETISM 1.2 Rare earth atoms The starting point for the understanding of the magnetism of the rare earths is the description of the electronic states, particularly of the

More information

Schrödinger equation for central potentials

Schrödinger equation for central potentials Chapter 2 Schrödinger equation for central potentials In this chapter we will extend the concepts and methods introduced in the previous chapter ifor a one-dimenional problem to a specific and very important

More information

Key concepts in Density Functional Theory

Key concepts in Density Functional Theory From the many body problem to the Kohn-Sham scheme ILM (LPMCN) CNRS, Université Lyon 1 - France European Theoretical Spectroscopy Facility (ETSF) December 12, 2012 Lyon Outline 1 The many-body problem

More information

Physics 342 Lecture 26. Angular Momentum. Lecture 26. Physics 342 Quantum Mechanics I

Physics 342 Lecture 26. Angular Momentum. Lecture 26. Physics 342 Quantum Mechanics I Physics 342 Lecture 26 Angular Momentum Lecture 26 Physics 342 Quantum Mechanics I Friday, April 2nd, 2010 We know how to obtain the energy of Hydrogen using the Hamiltonian operator but given a particular

More information

1 Commutators (10 pts)

1 Commutators (10 pts) Final Exam Solutions 37A Fall 0 I. Siddiqi / E. Dodds Commutators 0 pts) ) Consider the operator  = Ĵx Ĵ y + ĴyĴx where J i represents the total angular momentum in the ith direction. a) Express both

More information

Lectures 21 and 22: Hydrogen Atom. 1 The Hydrogen Atom 1. 2 Hydrogen atom spectrum 4

Lectures 21 and 22: Hydrogen Atom. 1 The Hydrogen Atom 1. 2 Hydrogen atom spectrum 4 Lectures and : Hydrogen Atom B. Zwiebach May 4, 06 Contents The Hydrogen Atom Hydrogen atom spectrum 4 The Hydrogen Atom Our goal here is to show that the two-body quantum mechanical problem of the hydrogen

More information

1 Schroenger s Equation for the Hydrogen Atom

1 Schroenger s Equation for the Hydrogen Atom Schroenger s Equation for the Hydrogen Atom Here is the Schroedinger equation in D in spherical polar coordinates. Note that the definitions of θ and φ are the exact reverse of what they are in mathematics.

More information

Chemistry 432 Problem Set 4 Spring 2018 Solutions

Chemistry 432 Problem Set 4 Spring 2018 Solutions Chemistry 4 Problem Set 4 Spring 18 Solutions 1. V I II III a b c A one-dimensional particle of mass m is confined to move under the influence of the potential x a V V (x) = a < x b b x c elsewhere and

More information

Quantum Mechanics in Three Dimensions

Quantum Mechanics in Three Dimensions Physics 342 Lecture 21 Quantum Mechanics in Three Dimensions Lecture 21 Physics 342 Quantum Mechanics I Monday, March 22nd, 21 We are used to the temporal separation that gives, for example, the timeindependent

More information

Density Functional Theory

Density Functional Theory Density Functional Theory March 26, 2009 ? DENSITY FUNCTIONAL THEORY is a method to successfully describe the behavior of atomic and molecular systems and is used for instance for: structural prediction

More information

Electrochemistry project, Chemistry Department, November Ab-initio Molecular Dynamics Simulation

Electrochemistry project, Chemistry Department, November Ab-initio Molecular Dynamics Simulation Electrochemistry project, Chemistry Department, November 2006 Ab-initio Molecular Dynamics Simulation Outline Introduction Ab-initio concepts Total energy concepts Adsorption energy calculation Project

More information

Strategies for Solving Kohn- Sham equations

Strategies for Solving Kohn- Sham equations Strategies for Solving Kohn- Sham equations Peter. E. Blöchl Institute for Theoretical Physics Clausthal University of Technology, Germany http://www.pt.tu-clausthal.de/atp/ 1 1 Appetizer: high-k oxides

More information

5.61 Physical Chemistry Exam III 11/29/12. MASSACHUSETTS INSTITUTE OF TECHNOLOGY Department of Chemistry Chemistry Physical Chemistry.

5.61 Physical Chemistry Exam III 11/29/12. MASSACHUSETTS INSTITUTE OF TECHNOLOGY Department of Chemistry Chemistry Physical Chemistry. MASSACHUSETTS INSTITUTE OF TECHNOLOGY Department of Chemistry Chemistry - 5.61 Physical Chemistry Exam III (1) PRINT your name on the cover page. (2) It is suggested that you READ THE ENTIRE EXAM before

More information

Computation of NRQCD Parameters in Potential Models

Computation of NRQCD Parameters in Potential Models Computation of NRQCD Parameters in Potential Models Brandon Willard Department of Physics, Wayne State University, Detroit, Michigan, 48202 August 2004 Abstract This paper gives details of computing the

More information

Session 5 (last revised: January 24, 2010) 5 1

Session 5 (last revised: January 24, 2010) 5 1 782 Session 5 (last revised: January 24, 21) 5 1 5 782 Session 5 a Follow-up to Numerical Derivative Round-Off Errors In Session 4, we looked at error plots for various ways to calculate numerical derivatives

More information

Density Functional Theory for Electrons in Materials

Density Functional Theory for Electrons in Materials Density Functional Theory for Electrons in Materials Richard M. Martin Department of Physics and Materials Research Laboratory University of Illinois at Urbana-Champaign 1 Density Functional Theory for

More information

One-electron Atom. (in spherical coordinates), where Y lm. are spherical harmonics, we arrive at the following Schrödinger equation:

One-electron Atom. (in spherical coordinates), where Y lm. are spherical harmonics, we arrive at the following Schrödinger equation: One-electron Atom The atomic orbitals of hydrogen-like atoms are solutions to the Schrödinger equation in a spherically symmetric potential. In this case, the potential term is the potential given by Coulomb's

More information

Introduction to DFT and Density Functionals. by Michel Côté Université de Montréal Département de physique

Introduction to DFT and Density Functionals. by Michel Côté Université de Montréal Département de physique Introduction to DFT and Density Functionals by Michel Côté Université de Montréal Département de physique Eamples Carbazole molecule Inside of diamant Réf: Jean-François Brière http://www.phys.umontreal.ca/~michel_

More information

SCIENCE VISION INSTITUTE For CSIR NET/JRF, GATE, JEST, TIFR & IIT-JAM Web:

SCIENCE VISION INSTITUTE For CSIR NET/JRF, GATE, JEST, TIFR & IIT-JAM Web: Test Series: CSIR NET/JRF Exam Physical Sciences Test Paper: Quantum Mechanics-I Instructions: 1. Attempt all Questions. Max Marks: 185 2. There is a negative marking of 1/4 for each wrong answer. 3. Each

More information

Angular Momentum. Andreas Wacker Mathematical Physics Lund University

Angular Momentum. Andreas Wacker Mathematical Physics Lund University Angular Momentum Andreas Wacker Mathematical Physics Lund University Commutation relations of (orbital) angular momentum Angular momentum in analogy with classical case L= r p satisfies commutation relations

More information

Quantum Mechanics Solutions. λ i λ j v j v j v i v i.

Quantum Mechanics Solutions. λ i λ j v j v j v i v i. Quantum Mechanics Solutions 1. (a) If H has an orthonormal basis consisting of the eigenvectors { v i } of A with eigenvalues λ i C, then A can be written in terms of its spectral decomposition as A =

More information

Why use pseudo potentials?

Why use pseudo potentials? Pseudo potentials Why use pseudo potentials? Reduction of basis set size effective speedup of calculation Reduction of number of electrons reduces the number of degrees of freedom For example in Pt: 10

More information

Printed from file Manuscripts/Stark/stark.tex on February 24, 2014 Stark Effect

Printed from file Manuscripts/Stark/stark.tex on February 24, 2014 Stark Effect Printed from file Manuscripts/Stark/stark.tex on February 4, 4 Stark Effect Robert Gilmore Physics Department, Drexel University, Philadelphia, PA 94 February 4, 4 Abstract An external electric field E

More information

1 Density functional theory (DFT)

1 Density functional theory (DFT) 1 Density functional theory (DFT) 1.1 Introduction Density functional theory is an alternative to ab initio methods for solving the nonrelativistic, time-independent Schrödinger equation H Φ = E Φ. The

More information

Lecture 4 Quantum mechanics in more than one-dimension

Lecture 4 Quantum mechanics in more than one-dimension Lecture 4 Quantum mechanics in more than one-dimension Background Previously, we have addressed quantum mechanics of 1d systems and explored bound and unbound (scattering) states. Although general concepts

More information

Chemistry 2. Lecture 1 Quantum Mechanics in Chemistry

Chemistry 2. Lecture 1 Quantum Mechanics in Chemistry Chemistry 2 Lecture 1 Quantum Mechanics in Chemistry Your lecturers 8am Assoc. Prof Timothy Schmidt Room 315 timothy.schmidt@sydney.edu.au 93512781 12pm Assoc. Prof. Adam J Bridgeman Room 222 adam.bridgeman@sydney.edu.au

More information

Introduction to DFTB. Marcus Elstner. July 28, 2006

Introduction to DFTB. Marcus Elstner. July 28, 2006 Introduction to DFTB Marcus Elstner July 28, 2006 I. Non-selfconsistent solution of the KS equations DFT can treat up to 100 atoms in routine applications, sometimes even more and about several ps in MD

More information

Quantum Mechanics: The Hydrogen Atom

Quantum Mechanics: The Hydrogen Atom Quantum Mechanics: The Hydrogen Atom 4th April 9 I. The Hydrogen Atom In this next section, we will tie together the elements of the last several sections to arrive at a complete description of the hydrogen

More information

Behind the "exciting" curtain: The (L)APW+lo method

Behind the exciting curtain: The (L)APW+lo method Behind the "exciting" curtain: The (L)APW+lo method Aug 7, 2016 Andris Gulans Humboldt-Universität zu Berlin Kohn-Sham equation Potential due to nuclei Exchange-correlation potential Potential due to electron

More information

Magnetism in low dimensions from first principles. Atomic magnetism. Gustav Bihlmayer. Gustav Bihlmayer

Magnetism in low dimensions from first principles. Atomic magnetism. Gustav Bihlmayer. Gustav Bihlmayer IFF 10 p. 1 Magnetism in low dimensions from first principles Atomic magnetism Gustav Bihlmayer Institut für Festkörperforschung, Quantum Theory of Materials Gustav Bihlmayer Institut für Festkörperforschung

More information

Chemistry 120A 2nd Midterm. 1. (36 pts) For this question, recall the energy levels of the Hydrogenic Hamiltonian (1-electron):

Chemistry 120A 2nd Midterm. 1. (36 pts) For this question, recall the energy levels of the Hydrogenic Hamiltonian (1-electron): April 6th, 24 Chemistry 2A 2nd Midterm. (36 pts) For this question, recall the energy levels of the Hydrogenic Hamiltonian (-electron): E n = m e Z 2 e 4 /2 2 n 2 = E Z 2 /n 2, n =, 2, 3,... where Ze is

More information

The electronic structure of materials 2 - DFT

The electronic structure of materials 2 - DFT Quantum mechanics 2 - Lecture 9 December 19, 2012 1 Density functional theory (DFT) 2 Literature Contents 1 Density functional theory (DFT) 2 Literature Historical background The beginnings: L. de Broglie

More information

Time Independent Perturbation Theory Contd.

Time Independent Perturbation Theory Contd. Time Independent Perturbation Theory Contd. A summary of the machinery for the Perturbation theory: H = H o + H p ; H 0 n >= E n n >; H Ψ n >= E n Ψ n > E n = E n + E n ; E n = < n H p n > + < m H p n

More information

Lecture #1. Review. Postulates of quantum mechanics (1-3) Postulate 1

Lecture #1. Review. Postulates of quantum mechanics (1-3) Postulate 1 L1.P1 Lecture #1 Review Postulates of quantum mechanics (1-3) Postulate 1 The state of a system at any instant of time may be represented by a wave function which is continuous and differentiable. Specifically,

More information

Physics 401: Quantum Mechanics I Chapter 4

Physics 401: Quantum Mechanics I Chapter 4 Physics 401: Quantum Mechanics I Chapter 4 Are you here today? A. Yes B. No C. After than midterm? 3-D Schroedinger Equation The ground state energy of the particle in a 3D box is ( 1 2 +1 2 +1 2 ) π2

More information

Quantum Physics II (8.05) Fall 2002 Assignment 11

Quantum Physics II (8.05) Fall 2002 Assignment 11 Quantum Physics II (8.05) Fall 00 Assignment 11 Readings Most of the reading needed for this problem set was already given on Problem Set 9. The new readings are: Phase shifts are discussed in Cohen-Tannoudji

More information

Introduction to Quantum Mechanics (Prelude to Nuclear Shell Model) Heisenberg Uncertainty Principle In the microscopic world,

Introduction to Quantum Mechanics (Prelude to Nuclear Shell Model) Heisenberg Uncertainty Principle In the microscopic world, Introduction to Quantum Mechanics (Prelude to Nuclear Shell Model) Heisenberg Uncertainty Principle In the microscopic world, x p h π If you try to specify/measure the exact position of a particle you

More information

Løsningsforslag Eksamen 18. desember 2003 TFY4250 Atom- og molekylfysikk og FY2045 Innføring i kvantemekanikk

Løsningsforslag Eksamen 18. desember 2003 TFY4250 Atom- og molekylfysikk og FY2045 Innføring i kvantemekanikk Eksamen TFY450 18. desember 003 - løsningsforslag 1 Oppgave 1 Løsningsforslag Eksamen 18. desember 003 TFY450 Atom- og molekylfysikk og FY045 Innføring i kvantemekanikk a. With Ĥ = ˆK + V = h + V (x),

More information

1.6. Quantum mechanical description of the hydrogen atom

1.6. Quantum mechanical description of the hydrogen atom 29.6. Quantum mechanical description of the hydrogen atom.6.. Hamiltonian for the hydrogen atom Atomic units To avoid dealing with very small numbers, let us introduce the so called atomic units : Quantity

More information

Variational Methods for Electronic Structure

Variational Methods for Electronic Structure Variational Methods for Electronic Structure The hydrogen atom is a two-body system consisting of a proton and an electron. If spin and relativistic effects are ignored, then the Schrödinger equation for

More information

Physible: Interactive Physics Collection MA198 Proposal Rough Draft

Physible: Interactive Physics Collection MA198 Proposal Rough Draft Physible: Interactive Physics Collection MA98 Proposal Rough Draft Brian Campbell-Deem Professor George Francis November 6 th 205 Abstract Physible conglomerates four smaller, physics-related programs

More information

Introduction to Density Functional Theory

Introduction to Density Functional Theory Introduction to Density Functional Theory S. Sharma Institut für Physik Karl-Franzens-Universität Graz, Austria 19th October 2005 Synopsis Motivation 1 Motivation : where can one use DFT 2 : 1 Elementary

More information

Intro to Nuclear and Particle Physics (5110)

Intro to Nuclear and Particle Physics (5110) Intro to Nuclear and Particle Physics (5110) March 13, 009 Nuclear Shell Model continued 3/13/009 1 Atomic Physics Nuclear Physics V = V r f r L r S r Tot Spin-Orbit Interaction ( ) ( ) Spin of e magnetic

More information

Solutions to exam : 1FA352 Quantum Mechanics 10 hp 1

Solutions to exam : 1FA352 Quantum Mechanics 10 hp 1 Solutions to exam 6--6: FA35 Quantum Mechanics hp Problem (4 p): (a) Define the concept of unitary operator and show that the operator e ipa/ is unitary (p is the momentum operator in one dimension) (b)

More information

Density Functional Theory: from theory to Applications

Density Functional Theory: from theory to Applications Density Functional Theory: from theory to Applications Uni Mainz November 29, 2010 The self interaction error and its correction Perdew-Zunger SIC Average-density approximation Weighted density approximation

More information

Quantum Modeling of Solids: Basic Properties

Quantum Modeling of Solids: Basic Properties 1.021, 3.021, 10.333, 22.00 : Introduction to Modeling and Simulation : Spring 2011 Part II Quantum Mechanical Methods : Lecture 5 Quantum Modeling of Solids: Basic Properties Jeffrey C. Grossman Department

More information

Physics 342 Lecture 23. Radial Separation. Lecture 23. Physics 342 Quantum Mechanics I

Physics 342 Lecture 23. Radial Separation. Lecture 23. Physics 342 Quantum Mechanics I Physics 342 Lecture 23 Radial Separation Lecture 23 Physics 342 Quantum Mechanics I Friday, March 26th, 2010 We begin our spherical solutions with the simplest possible case zero potential. Aside from

More information

Pseudopotential methods for DFT calculations

Pseudopotential methods for DFT calculations Pseudopotential methods for DFT calculations Lorenzo Paulatto Scuola Internazionale Superiore di Studi Avanzati and CNR-INFM DEMOCRITOS National Simulation Center Tieste Italy July 9, 2008 Outline pseudopotential

More information

Goal: find Lorentz-violating corrections to the spectrum of hydrogen including nonminimal effects

Goal: find Lorentz-violating corrections to the spectrum of hydrogen including nonminimal effects Goal: find Lorentz-violating corrections to the spectrum of hydrogen including nonminimal effects Method: Rayleigh-Schrödinger Perturbation Theory Step 1: Find the eigenvectors ψ n and eigenvalues ε n

More information

PHYS 771, Quantum Mechanics, Final Exam, Fall 2011 Instructor: Dr. A. G. Petukhov. Solutions

PHYS 771, Quantum Mechanics, Final Exam, Fall 2011 Instructor: Dr. A. G. Petukhov. Solutions PHYS 771, Quantum Mechanics, Final Exam, Fall 11 Instructor: Dr. A. G. Petukhov Solutions 1. Apply WKB approximation to a particle moving in a potential 1 V x) = mω x x > otherwise Find eigenfunctions,

More information

Solid State Theory: Band Structure Methods

Solid State Theory: Band Structure Methods Solid State Theory: Band Structure Methods Lilia Boeri Wed., 11:15-12:45 HS P3 (PH02112) http://itp.tugraz.at/lv/boeri/ele/ Plan of the Lecture: DFT1+2: Hohenberg-Kohn Theorem and Kohn and Sham equations.

More information

Introduction to Computational Chemistry

Introduction to Computational Chemistry Introduction to Computational Chemistry Vesa Hänninen Laboratory of Physical Chemistry room B430, Chemicum 4th floor vesa.hanninen@helsinki.fi September 3, 2013 Introduction and theoretical backround September

More information

The Overhauser Instability

The Overhauser Instability The Overhauser Instability Zoltán Radnai and Richard Needs TCM Group ESDG Talk 14th February 2007 Typeset by FoilTEX Introduction Hartree-Fock theory and Homogeneous Electron Gas Noncollinear spins and

More information

1 Reduced Mass Coordinates

1 Reduced Mass Coordinates Coulomb Potential Radial Wavefunctions R. M. Suter April 4, 205 Reduced Mass Coordinates In classical mechanics (and quantum) problems involving several particles, it is convenient to separate the motion

More information

Phys 622 Problems Chapter 5

Phys 622 Problems Chapter 5 1 Phys 622 Problems Chapter 5 Problem 1 The correct basis set of perturbation theory Consider the relativistic correction to the electron-nucleus interaction H LS = α L S, also known as the spin-orbit

More information

We now turn to our first quantum mechanical problems that represent real, as

We now turn to our first quantum mechanical problems that represent real, as 84 Lectures 16-17 We now turn to our first quantum mechanical problems that represent real, as opposed to idealized, systems. These problems are the structures of atoms. We will begin first with hydrogen-like

More information

8.05 Quantum Physics II, Fall 2011 FINAL EXAM Thursday December 22, 9:00 am -12:00 You have 3 hours.

8.05 Quantum Physics II, Fall 2011 FINAL EXAM Thursday December 22, 9:00 am -12:00 You have 3 hours. 8.05 Quantum Physics II, Fall 0 FINAL EXAM Thursday December, 9:00 am -:00 You have 3 hours. Answer all problems in the white books provided. Write YOUR NAME and YOUR SECTION on your white books. There

More information

Dimensional analysis

Dimensional analysis Dimensional analysis Calvin W. Johnson September 9, 04 Dimensional analysis Dimensional analysis is a powerful and important tool in calculations. In fact, you should make it a habit to automatically use

More information

Integrated Computational Materials Engineering Education

Integrated Computational Materials Engineering Education Integrated Computational Materials Engineering Education Lecture on Density Functional Theory An Introduction Mark Asta Dept. of Materials Science and Engineering, University of California, Berkeley &

More information

Solution to Problem Set No. 6: Time Independent Perturbation Theory

Solution to Problem Set No. 6: Time Independent Perturbation Theory Solution to Problem Set No. 6: Time Independent Perturbation Theory Simon Lin December, 17 1 The Anharmonic Oscillator 1.1 As a first step we invert the definitions of creation and annihilation operators

More information

In the following, we investigate the time-dependent two-component wave function ψ(t) = ( )

In the following, we investigate the time-dependent two-component wave function ψ(t) = ( ) Ph.D. Qualifier, Quantum mechanics DO ONLY 3 OF THE 4 QUESTIONS Note the additional material for questions 1 and 3 at the end. PROBLEM 1. In the presence of a magnetic field B = (B x, B y, B z ), the dynamics

More information

Lecture 7. More dimensions

Lecture 7. More dimensions Lecture 7 More dimensions 67 68 LECTURE 7. MORE DIMENSIONS 7.1 Introduction In this lecture we generalize the concepts introduced so far to systems that evolve in more than one spatial dimension. While

More information

2m r2 (~r )+V (~r ) (~r )=E (~r )

2m r2 (~r )+V (~r ) (~r )=E (~r ) Review of the Hydrogen Atom The Schrodinger equation (for 1D, 2D, or 3D) can be expressed as: ~ 2 2m r2 (~r, t )+V (~r ) (~r, t )=i~ @ @t The Laplacian is the divergence of the gradient: r 2 =r r The time-independent

More information

Notes on excitation of an atom or molecule by an electromagnetic wave field. F. Lanni / 11feb'12 / rev9sept'14

Notes on excitation of an atom or molecule by an electromagnetic wave field. F. Lanni / 11feb'12 / rev9sept'14 Notes on excitation of an atom or molecule by an electromagnetic wave field. F. Lanni / 11feb'12 / rev9sept'14 Because the wavelength of light (400-700nm) is much greater than the diameter of an atom (0.07-0.35

More information

Outlines of Quantum Physics

Outlines of Quantum Physics Duality S. Eq Hydrogen Outlines of 1 Wave-Particle Duality 2 The Schrödinger Equation 3 The Hydrogen Atom Schrödinger Eq. of the Hydrogen Atom Noninteracting Particles and Separation of Variables The One-Particle

More information

The Hydrogen Atom Chapter 20

The Hydrogen Atom Chapter 20 4/4/17 Quantum mechanical treatment of the H atom: Model; The Hydrogen Atom Chapter 1 r -1 Electron moving aroundpositively charged nucleus in a Coulombic field from the nucleus. Potential energy term

More information