sin(kr) cos(kr) = 0, a σ (k) a σ (k) = 1 R a Semi-momentum states cos(kr), σ = +1 sin(kr), σ = 1. C σ k (r)t r a N a k = m 2π N

Size: px
Start display at page:

Download "sin(kr) cos(kr) = 0, a σ (k) a σ (k) = 1 R a Semi-momentum states cos(kr), σ = +1 sin(kr), σ = 1. C σ k (r)t r a N a k = m 2π N"

Transcription

1 Semi-momentum states Mix momenta +k and k for k 0,π. Introduce function C σ k (r) = Semi-momentum state { cos(kr), σ = +1 sin(kr), σ = 1. Useful trigonometric relationships C ± k ( r) = ±C± k (r), C ± k (r + d) = C± k (r)c+ k (d) C k (r)c k (d). a σ (k) = 1 N 1 Na k = m 2π N r=0 C σ k (r)t r a, m =1,..., N/2 1, σ = ±1 States with same k, different σ are orthogonal a σ (k) a σ (k) = 1 R a N a r=1 sin(kr) cos(kr) = 0, 17

2 Normalization of semi-momentum states N a = ( N R a ) 2 R a [Ck σ (r)] 2 = N 2 r=1 Hamiltonian: ac with H H a ± (k) = N j=0 h j a The matrix elements are 2R a b τ (k) H j a σ (k) = τ (σ τ)/2 h j a R ( a C + k R (l j) b ± j (k) C k (l j) b j ), (k) bj N bj N a C στ k (l j ) σ is mot a conserved quantum number H and T mix σ=+1 and σ= 1 states the H matrix is twice as large as for momentum states 18

3 Why are the semi-momentum states useful then? Because we can construct a real-valued basis: Semi-momentum states with parity This state has definite parity with p=+1 or p= 1 a σ (k, p) = 1 N 1 N σ a r=0 C σ k (r)t r (1 + pp ) a (k, 1) and (k,+1) blocks roughly of the same size as original k blocks but these states are real, not complex! For k 0,π, the p=-1 and p=+1 states are degenerate P,T transformations example: N=8;note that T 5 P a>= a> such P,T relationships will affect normalization and H-elements 19

4 Normalization: We have to check whether or not T m P a = a for some m {1,..., N 1} Simple algebra gives Na σ = N 2 { 1, T m P a a R a 1+σpcos(km), T m P a = a In the latter case the σ=-1 and σ=+1 states are not orthogonal Then only one of them should be included in the basis convention: use σ=+1 if 1+σpcos(km) 0, else σ=-1 If both σ=+1 and σ= 1 are present: we store 2 copies of the same representative we will store the σ value along with the periodicity of the representative 20

5 Pseudocode: semi-momentum, parity basis construction do s =0, 2 N 1 call checkstate(s, R, m) do σ = ±1 (do only σ = +1 if k = 0 or k = N/2) if (m 1) then if (1 + σp cos(ikm2π/n ) = 0) R = 1 if (σ = 1 and 1 σp cos(ikm2π/n ) 0); R = 1 endif if R>0 then a = a + 1; s a = s; R a = σr; m a = m endif In the subroutine checkstate(), we now find whether T m P a = a for some m {1,..., N 1} m= 1 if there is no such transformation if m -1, then the σ=+1 and σ=-1 states are not orthogonal use only the σ=+1 state if it has non-zero normalization use the σ=-1 state if σ=+1 has normalization=0 R= 1 for not including in the basis 21

6 the subroutine checkstate() is modified to gives us: periodicity R (R= 1 if incompatible) m>0 if T m P s>= s> m= 1 if no such relationship check all translations of s> { construct reflected state P s> { check all translations of P s> subroutine checkstate(s, R, m) R = 1 if ( P i s[i] n ) return t = s do i =1,N t = cyclebits(t, N) if (t <s) then return elseif (t = s) then if (mod(k, N/i) 0) return R = i; exit endif t = reflectbits(s, N); m = 1 do i =0,R 1 if (t <s) then R = 1; return elseif (t = s) then m = i; return endif t = cyclebits(t, N) 22

7 Hamiltonian : Act with an operator Hj on a representative state: H j a = h j ap q j T l j b j We can write H acting on a basis state as H a σ (k, p) = N j=0 h j a(σp) q j N σ a T m P b j = b j If, for some m, N σ b j 1 σp cos(km) Nb σ = j 1+σpcos(km) = N 1 r=0 then C σ k (r + l j )(1 + pp )T r b j Using the properties (trigonometry) of the C-functions: N N σ H a σ (k, p) = h j a(σp) q bj j j=0 N σ a ( cos(kl j ) b σ j (k, p) σ N σ b j N σ b j ) sin(kl j ) b σ (k, p) ) sin(km) 1+σp cos(km) b j (k, p) b± j (k, p) = p else the ratio is one and the + and states are orthogonal 23

8 The matrix elements are diagonal in σ N σ bj b σ j (k, p) H j a σ (k, p) = h j a(σp) q j off-diagonal in σ N σ a { cos(klj ), P b j T m b j cos(kl j )+σp cos(k[l j m]) 1+σp cos(km), P b j = T m b j b σ j (k, p) H j a σ (k, p) = h j a(σp) q j Na σ { σ sin(klj ), P b j T m b j, N σ b j σ sin(kl j )+p sin(k[l j m]) 1 σp cos(km), P b j = T m b j, 24

9 Pseudocode: semi-momentum, parity hamiltonian If 2 copies of the same representative, σ= 1 and σ=+1: do both in the same loop iteration examine the previous and next element carry out the loop iteration only if representative found for the first time do a =1,M if (a >1 and s a = s a 1 ) then cycle elseif (a <M and s a = s a+1 ) then n =2 else n =1 endif... n is the number of copies of the representative do i = a, a + n 1 H(a, a) =H(a, a) +E z diagonal matrix elements Ez = diagonal energy 25

10 s = flip(s a, i, j) call representative(s, r, l, q) call findstate(r, b) if (b 0) then if (b >1 and s b = s b 1 ) then m = 2; b = b 1 elseif (b < M and s b = s b+1 ) then m =2 else m =1 endif do j = b, b + m 1 do i = a, a + n 1 H(i, j) =H(i, j) +helement(i, j, l, q) endif subroutine representative(s, r, l, q)... t = reflectbits(s, N); q =0 do i =1,N 1 t = cyclebits(t, N) if (t <r) then r = t; l = i; q =1endif construct off-diagonal matrix elements helement() computes the values based on stored info and l,q find the representative r of s translation and reflection numbers l,q 26

11 Using spin-inversion symmetry Spin inversion operator: Z S z 1,S z 2,..., S z N = S z 1, S z 2,..., S z N In the magnetization block m z =0 we can use eigenstates of Z a σ (k, p, z) = 1 N 1 C N σ k σ (r)t r (1 + pp )(1 + zz) a a r=0 Z a σ (k, p, z) = z a σ (k, p, z), z = ±1 Normalization: must check how a representative transforms under Z,P,T 1) T m P a a, T m Z a a T m PZ a a 2) T m P a = a, T m Z a a T m PZ a a 3) T m P a a, T m Z a = a T m PZ a a 4) T m P a a, T m Z a a T m PZ a = a 5) T m P a = a, T n Z a = a T m+n PZ a = a For cases 2,4,5 only σ=+1 or σ= 1 included 1, 1) Na σ = 2N 2 1+σpcos(km), 2) 1+zcos(km), 3) R a 1+σpz cos(km), 4) [1 + σp cos(km)][1 + z cos(kn)], 5) 27

12 Hamiltonian: acting on a state gives a transformed representative H j a = h j ap q j Z g j T l j b j q j {0, 1}, g j = {0, 1}, l j = {0, 1,..., N 1} After some algebra... we can obtain the matrix elements diagonal in σ b σ j (k, p) H j a σ (k, p) = h j a(σp) q j z g j off-diagonal in σ b σ j (k, p) H j a σ (k, p) = h j a(σp) q j z g j N τ bj N σ a cos(kl j ), 1), 3) cos(kl j )+σp cos(k[l j m]) 1+σp cos(km), 2), 5) cos(kl j )+σpz cos(k[l j m]) 1+σpz cos(km), 4) N τ bj N σ a σ sin(kl j ), 1), 3) σ sin(kl j )+p sin(k[l j m]) 1 σp cos(km), 2), 5) σ sin(kl j )+pz sin(k[l j m]) 1 σpz cos(km), 4) 28

13 Example: block sizes k=0, mz=0 (largest block) (p = ±1,z = ±1) N (+1, +1) (+1, 1) ( 1, +1) ( 1, 1) Total spin S conservation more difficult to exploit complicated basis states calculate S using S 2 =S(S+1) N N S 2 = S i S j i=1 j=1 = 2 i<j S i S j N Full diagonalization; expectation values shorthand block label: j=(mz,k,p) or j=(mz=0,k,p,z) D 1 j H j D j = E j, n j A n j =[D 1 AD j ] nn T>0: sum over all blocks j and states in block n=0,mj 1 A = 1 Z j M j 1 n=0 e βe j,n [D 1 j A j U j ] nn, Z = j Ej = diagonal (energy) matrix, Ej,n = energies, n=0,...,mj 1 j M j 1 n=0 e βe j,n Full diagonalization limited to small N; N=

14 Example: Thermodynamics some quantities can be computed using only the magnetization mz=0 sector spin-inversion symmetry can be used, smallest blocks spin-s state is (2S+1)-fold degenerate (no magnetix field) weight factor possible spin dependence of expectation value average over mz= S,...,S C = d H = 1 dt χ z = d m z = 1 dh z T ( H 2 T 2 H 2) ( m 2 z m z 2) m z =0, m 2 z = m2 x + m 2 y + m 2 z 3 = S2 3 = S(S + 1) 3 Compared with leading high-t forms χ = (1/4)/T C = (3/13)/T 2 30

15 The Lanczos method If we need only the ground state and a small number of excitations can use Krylov space methods, which work for much larger matrices basis states with 10 7 states or more can be easily handled (30-40 spins) The Krylov space and projecting out the ground state Start with an arbitrary state ψ it has an expansion in eigenstates of H; act with a high power Λ of H H Λ Ψ = ( ( ) Λ c n En Λ n = E0 Λ E1 c c ) E n 0 For large Λ, if the state with largest En dominates the sum one may have to subtract a constant, H C, to ensure ground state even better to use linear combination of states generated for different Λ ψ a = Λ m=0 ψ a (m)h m Ψ, diagonalize H in this basis a =0,..., Λ In the Lanczos basis, H is tridiagonal, convenient to generate and use Normally M= basis states is enough; easy to diagonalize H 31

16 Constructing the Lanczos basis First: construct orthogonal but not normalized basis {fm}. Define N m = f m f m, H mm = f m H f m The first state f0> is arbitrary, e.g., random. The next one is f 1 = H f 0 a 0 f 0 Demand orthogonality f 1 f 0 = f 0 H f 0 a 0 f 0 f 0 = H 00 a 0 N 0 a 0 = H 00 /N 0 The next state and its overlaps with the previous states f 2 = H f 1 a 1 f 1 b 0 f 0 f 2 f 1 = H 11 a 1 N 1, f 2 f 0 = N 1 b 0 N 0 For orthogonal states a 1 = H 11 /N 1, b 0 = N 1 /N 0 All subsequent states are constructed according to f m+1 = H f m a m f m b m 1 f m 1 a m = H mm /N m, b m 1 = N m /N m 1 Easy to prove orthogonality of all these states (<fm+1 fm>=0 is enough) 32

17 The hamiltonian in the Lanczos basis Rewrite the state generation formula H f m = f m+1 + a m f m + b m 1 f m 1 Because of the orthogonality, the only non-0 matrix elements are f m 1 H f m = b m 1 N m 1 = N m f m H f m = a m N m f m+1 H f m = N m+1 But the f-states or not normalized. The normalized states are: φ m = 1 f m Nm In this basis the H-matrix is φ m 1 H φ m = b m 1 φ m H φ m = a m φ m+1 H φ m = b m 33

Exact diagonalization methods

Exact diagonalization methods Summer School on Computational Statistical Physics August 4-11, 2010, NCCU, Taipei, Taiwan Exact diagonalization methods Anders W. Sandvik, Boston University Representation of states in the computer bit

More information

T S z 1,S z 2,..., S z N = S z N,S z 1,..., S z N 1

T S z 1,S z 2,..., S z N = S z N,S z 1,..., S z N 1 Momentum states (translationally invariant systems) A periodic chain (ring), translationally invariant eigenstates with a fixed momentum (crystal momentum ) quantum number k T n =e ik n k = m 2π, m =0,...,

More information

Addition of Angular Momenta

Addition of Angular Momenta Addition of Angular Momenta What we have so far considered to be an exact solution for the many electron problem, should really be called exact non-relativistic solution. A relativistic treatment is needed

More information

The Quantum Heisenberg Ferromagnet

The Quantum Heisenberg Ferromagnet The Quantum Heisenberg Ferromagnet Soon after Schrödinger discovered the wave equation of quantum mechanics, Heisenberg and Dirac developed the first successful quantum theory of ferromagnetism W. Heisenberg,

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

Numerical diagonalization studies of quantum spin chains

Numerical diagonalization studies of quantum spin chains PY 502, Computational Physics, Fall 2016 Anders W. Sandvik, Boston University Numerical diagonalization studies of quantum spin chains Introduction to computational studies of spin chains Using basis states

More information

Applications of Renormalization Group Methods in Nuclear Physics 2

Applications of Renormalization Group Methods in Nuclear Physics 2 Applications of Renormalization Group Methods in Nuclear Physics 2 Dick Furnstahl Department of Physics Ohio State University HUGS 2014 Outline: Lecture 2 Lecture 2: SRG in practice Recap from lecture

More information

Ground State Projector QMC in the valence-bond basis

Ground State Projector QMC in the valence-bond basis Quantum Monte Carlo Methods at Work for Novel Phases of Matter Trieste, Italy, Jan 23 - Feb 3, 2012 Ground State Projector QMC in the valence-bond basis Anders. Sandvik, Boston University Outline: The

More information

v(r i r j ) = h(r i )+ 1 N

v(r i r j ) = h(r i )+ 1 N Chapter 1 Hartree-Fock Theory 1.1 Formalism For N electrons in an external potential V ext (r), the many-electron Hamiltonian can be written as follows: N H = [ p i i=1 m +V ext(r i )]+ 1 N N v(r i r j

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

H ψ = E ψ. Introduction to Exact Diagonalization. Andreas Läuchli, New states of quantum matter MPI für Physik komplexer Systeme - Dresden

H ψ = E ψ. Introduction to Exact Diagonalization. Andreas Läuchli, New states of quantum matter MPI für Physik komplexer Systeme - Dresden H ψ = E ψ Introduction to Exact Diagonalization Andreas Läuchli, New states of quantum matter MPI für Physik komplexer Systeme - Dresden http://www.pks.mpg.de/~aml laeuchli@comp-phys.org Simulations of

More information

The quantum state as a vector

The quantum state as a vector The quantum state as a vector February 6, 27 Wave mechanics In our review of the development of wave mechanics, we have established several basic properties of the quantum description of nature:. A particle

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

Degenerate Perturbation Theory. 1 General framework and strategy

Degenerate Perturbation Theory. 1 General framework and strategy Physics G6037 Professor Christ 12/22/2015 Degenerate Perturbation Theory The treatment of degenerate perturbation theory presented in class is written out here in detail. The appendix presents the underlying

More information

Problem Set 2 Due Tuesday, September 27, ; p : 0. (b) Construct a representation using five d orbitals that sit on the origin as a basis: 1

Problem Set 2 Due Tuesday, September 27, ; p : 0. (b) Construct a representation using five d orbitals that sit on the origin as a basis: 1 Problem Set 2 Due Tuesday, September 27, 211 Problems from Carter: Chapter 2: 2a-d,g,h,j 2.6, 2.9; Chapter 3: 1a-d,f,g 3.3, 3.6, 3.7 Additional problems: (1) Consider the D 4 point group and use a coordinate

More information

Kitaev honeycomb lattice model: from A to B and beyond

Kitaev honeycomb lattice model: from A to B and beyond Kitaev honeycomb lattice model: from A to B and beyond Jiri Vala Department of Mathematical Physics National University of Ireland at Maynooth Postdoc: PhD students: Collaborators: Graham Kells Ahmet Bolukbasi

More information

in-medium pair wave functions the Cooper pair wave function the superconducting order parameter anomalous averages of the field operators

in-medium pair wave functions the Cooper pair wave function the superconducting order parameter anomalous averages of the field operators (by A. A. Shanenko) in-medium wave functions in-medium pair-wave functions and spatial pair particle correlations momentum condensation and ODLRO (off-diagonal long range order) U(1) symmetry breaking

More information

Quantum Physics III (8.06) Spring 2008 Final Exam Solutions

Quantum Physics III (8.06) Spring 2008 Final Exam Solutions Quantum Physics III (8.6) Spring 8 Final Exam Solutions May 19, 8 1. Short answer questions (35 points) (a) ( points) α 4 mc (b) ( points) µ B B, where µ B = e m (c) (3 points) In the variational ansatz,

More information

Time-Independent Perturbation Theory

Time-Independent Perturbation Theory 4 Phys46.nb Time-Independent Perturbation Theory.. Overview... General question Assuming that we have a Hamiltonian, H = H + λ H (.) where λ is a very small real number. The eigenstates of the Hamiltonian

More information

The 1+1-dimensional Ising model

The 1+1-dimensional Ising model Chapter 4 The 1+1-dimensional Ising model The 1+1-dimensional Ising model is one of the most important models in statistical mechanics. It is an interacting system, and behaves accordingly. Yet for a variety

More information

Quantum Mechanics FKA081/FIM400 Final Exam 28 October 2015

Quantum Mechanics FKA081/FIM400 Final Exam 28 October 2015 Quantum Mechanics FKA081/FIM400 Final Exam 28 October 2015 Next review time for the exam: December 2nd between 14:00-16:00 in my room. (This info is also available on the course homepage.) Examinator:

More information

arxiv:quant-ph/ v2 24 Dec 2003

arxiv:quant-ph/ v2 24 Dec 2003 Quantum Entanglement in Heisenberg Antiferromagnets V. Subrahmanyam Department of Physics, Indian Institute of Technology, Kanpur, India. arxiv:quant-ph/0309004 v2 24 Dec 2003 Entanglement sharing among

More information

Isotropic harmonic oscillator

Isotropic harmonic oscillator Isotropic harmonic oscillator 1 Isotropic harmonic oscillator The hamiltonian of the isotropic harmonic oscillator is H = h m + 1 mω r (1) = [ h d m dρ + 1 ] m ω ρ, () ρ=x,y,z a sum of three one-dimensional

More information

Using the PGOPHER program to link experimental spectra with theory Rotations

Using the PGOPHER program to link experimental spectra with theory Rotations Using the PGOPHER program to link experimental spectra with theory Rotations Colin M. Western chool of Chemistry, University of Bristol, Bristol B8 1T, UK Email : C.M.Western@bristol.ac.uk http://pgopher.chm.bris.ac.uk

More information

Simple Harmonic Oscillator

Simple Harmonic Oscillator Classical harmonic oscillator Linear force acting on a particle (Hooke s law): F =!kx From Newton s law: F = ma = m d x dt =!kx " d x dt + # x = 0, # = k / m Position and momentum solutions oscillate in

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

Physics 215 Quantum Mechanics 1 Assignment 1

Physics 215 Quantum Mechanics 1 Assignment 1 Physics 5 Quantum Mechanics Assignment Logan A. Morrison January 9, 06 Problem Prove via the dual correspondence definition that the hermitian conjugate of α β is β α. By definition, the hermitian conjugate

More information

ψ s a ˆn a s b ˆn b ψ Hint: Because the state is spherically symmetric the answer can depend only on the angle between the two directions.

ψ s a ˆn a s b ˆn b ψ Hint: Because the state is spherically symmetric the answer can depend only on the angle between the two directions. 1. Quantum Mechanics (Fall 2004) Two spin-half particles are in a state with total spin zero. Let ˆn a and ˆn b be unit vectors in two arbitrary directions. Calculate the expectation value of the product

More information

Coupling of Angular Momenta Isospin Nucleon-Nucleon Interaction

Coupling of Angular Momenta Isospin Nucleon-Nucleon Interaction Lecture 5 Coupling of Angular Momenta Isospin Nucleon-Nucleon Interaction WS0/3: Introduction to Nuclear and Particle Physics,, Part I I. Angular Momentum Operator Rotation R(θ): in polar coordinates the

More information

Ket space as a vector space over the complex numbers

Ket space as a vector space over the complex numbers Ket space as a vector space over the complex numbers kets ϕ> and complex numbers α with two operations Addition of two kets ϕ 1 >+ ϕ 2 > is also a ket ϕ 3 > Multiplication with complex numbers α ϕ 1 >

More information

G : Quantum Mechanics II

G : Quantum Mechanics II G5.666: Quantum Mechanics II Notes for Lecture 5 I. REPRESENTING STATES IN THE FULL HILBERT SPACE Given a representation of the states that span the spin Hilbert space, we now need to consider the problem

More information

Alkali metals show splitting of spectral lines in absence of magnetic field. s lines not split p, d lines split

Alkali metals show splitting of spectral lines in absence of magnetic field. s lines not split p, d lines split Electron Spin Electron spin hypothesis Solution to H atom problem gave three quantum numbers, n,, m. These apply to all atoms. Experiments show not complete description. Something missing. Alkali metals

More information

5.5. Representations. Phys520.nb Definition N is called the dimensions of the representations The trivial presentation

5.5. Representations. Phys520.nb Definition N is called the dimensions of the representations The trivial presentation Phys50.nb 37 The rhombohedral and hexagonal lattice systems are not fully compatible with point group symmetries. Knowing the point group doesn t uniquely determine the lattice systems. Sometimes we can

More information

Second quantization: where quantization and particles come from?

Second quantization: where quantization and particles come from? 110 Phys460.nb 7 Second quantization: where quantization and particles come from? 7.1. Lagrangian mechanics and canonical quantization Q: How do we quantize a general system? 7.1.1.Lagrangian Lagrangian

More information

Lecture 8 Nature of ensemble: Role of symmetry, interactions and other system conditions: Part II

Lecture 8 Nature of ensemble: Role of symmetry, interactions and other system conditions: Part II Lecture 8 Nature of ensemble: Role of symmetry, interactions and other system conditions: Part II We continue our discussion of symmetries and their role in matrix representation in this lecture. An example

More information

I. Perturbation Theory and the Problem of Degeneracy[?,?,?]

I. Perturbation Theory and the Problem of Degeneracy[?,?,?] MASSACHUSETTS INSTITUTE OF TECHNOLOGY Chemistry 5.76 Spring 19 THE VAN VLECK TRANSFORMATION IN PERTURBATION THEORY 1 Although frequently it is desirable to carry a perturbation treatment to second or third

More information

Quantum Physics II (8.05) Fall 2004 Assignment 3

Quantum Physics II (8.05) Fall 2004 Assignment 3 Quantum Physics II (8.5) Fall 24 Assignment 3 Massachusetts Institute of Technology Physics Department Due September 3, 24 September 23, 24 7:pm This week we continue to study the basic principles of quantum

More information

Quantum wires, orthogonal polynomials and Diophantine approximation

Quantum wires, orthogonal polynomials and Diophantine approximation Quantum wires, orthogonal polynomials and Diophantine approximation Introduction Quantum Mechanics (QM) is a linear theory Main idea behind Quantum Information (QI): use the superposition principle of

More information

Statistical Interpretation

Statistical Interpretation Physics 342 Lecture 15 Statistical Interpretation Lecture 15 Physics 342 Quantum Mechanics I Friday, February 29th, 2008 Quantum mechanics is a theory of probability densities given that we now have an

More information

Physics 221A Fall 2017 Notes 27 The Variational Method

Physics 221A Fall 2017 Notes 27 The Variational Method Copyright c 2018 by Robert G. Littlejohn Physics 221A Fall 2017 Notes 27 The Variational Method 1. Introduction Very few realistic problems in quantum mechanics are exactly solvable, so approximation methods

More information

Topological insulator with time-reversal symmetry

Topological insulator with time-reversal symmetry Phys620.nb 101 7 Topological insulator with time-reversal symmetry Q: Can we get a topological insulator that preserves the time-reversal symmetry? A: Yes, with the help of the spin degree of freedom.

More information

Martin Schnabl. Institute of Physics AS CR. Collaborators: T. Kojita, M. Kudrna, C. Maccaferri, T. Masuda and M. Rapčák

Martin Schnabl. Institute of Physics AS CR. Collaborators: T. Kojita, M. Kudrna, C. Maccaferri, T. Masuda and M. Rapčák Martin Schnabl Collaborators: T. Kojita, M. Kudrna, C. Maccaferri, T. Masuda and M. Rapčák Institute of Physics AS CR 36th Winter School Geometry and Physics, Srní, January 22nd, 2016 2d Conformal Field

More information

Particle Physics. Michaelmas Term 2011 Prof. Mark Thomson. Handout 2 : The Dirac Equation. Non-Relativistic QM (Revision)

Particle Physics. Michaelmas Term 2011 Prof. Mark Thomson. Handout 2 : The Dirac Equation. Non-Relativistic QM (Revision) Particle Physics Michaelmas Term 2011 Prof. Mark Thomson + e - e + - + e - e + - + e - e + - + e - e + - Handout 2 : The Dirac Equation Prof. M.A. Thomson Michaelmas 2011 45 Non-Relativistic QM (Revision)

More information

$ +! j. % i PERTURBATION THEORY AND SUBGROUPS (REVISED 11/15/08)

$ +! j. % i PERTURBATION THEORY AND SUBGROUPS (REVISED 11/15/08) PERTURBATION THEORY AND SUBGROUPS REVISED 11/15/08) The use of groups and their subgroups is of much importance when perturbation theory is employed in understanding molecular orbital theory and spectroscopy

More information

(1.1) In particular, ψ( q 1, m 1 ; ; q N, m N ) 2 is the probability to find the first particle

(1.1) In particular, ψ( q 1, m 1 ; ; q N, m N ) 2 is the probability to find the first particle Chapter 1 Identical particles 1.1 Distinguishable particles The Hilbert space of N has to be a subspace H = N n=1h n. Observables Ân of the n-th particle are self-adjoint operators of the form 1 1 1 1

More information

1 Quantum field theory and Green s function

1 Quantum field theory and Green s function 1 Quantum field theory and Green s function Condensed matter physics studies systems with large numbers of identical particles (e.g. electrons, phonons, photons) at finite temperature. Quantum field theory

More information

20 The Hydrogen Atom. Ze2 r R (20.1) H( r, R) = h2 2m 2 r h2 2M 2 R

20 The Hydrogen Atom. Ze2 r R (20.1) H( r, R) = h2 2m 2 r h2 2M 2 R 20 The Hydrogen Atom 1. We want to solve the time independent Schrödinger Equation for the hydrogen atom. 2. There are two particles in the system, an electron and a nucleus, and so we can write the Hamiltonian

More information

Quantization of the Spins

Quantization of the Spins Chapter 5 Quantization of the Spins As pointed out already in chapter 3, the external degrees of freedom, position and momentum, of an ensemble of identical atoms is described by the Scödinger field operator.

More information

Lecture 11: Long-wavelength expansion in the Neel state Energetic terms

Lecture 11: Long-wavelength expansion in the Neel state Energetic terms Lecture 11: Long-wavelength expansion in the Neel state Energetic terms In the last class we derived the low energy effective Hamiltonian for a Mott insulator. This derivation is an example of the kind

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

Rotational motion of a rigid body spinning around a rotational axis ˆn;

Rotational motion of a rigid body spinning around a rotational axis ˆn; Physics 106a, Caltech 15 November, 2018 Lecture 14: Rotations The motion of solid bodies So far, we have been studying the motion of point particles, which are essentially just translational. Bodies with

More information

LS coupling. 2 2 n + H s o + H h f + H B. (1) 2m

LS coupling. 2 2 n + H s o + H h f + H B. (1) 2m LS coupling 1 The big picture We start from the Hamiltonian of an atomic system: H = [ ] 2 2 n Ze2 1 + 1 e 2 1 + H s o + H h f + H B. (1) 2m n e 4πɛ 0 r n 2 4πɛ 0 r nm n,m Here n runs pver the electrons,

More information

Particle Physics Dr. Alexander Mitov Handout 2 : The Dirac Equation

Particle Physics Dr. Alexander Mitov Handout 2 : The Dirac Equation Dr. A. Mitov Particle Physics 45 Particle Physics Dr. Alexander Mitov µ + e - e + µ - µ + e - e + µ - µ + e - e + µ - µ + e - e + µ - Handout 2 : The Dirac Equation Dr. A. Mitov Particle Physics 46 Non-Relativistic

More information

2 Canonical quantization

2 Canonical quantization Phys540.nb 7 Canonical quantization.1. Lagrangian mechanics and canonical quantization Q: How do we quantize a general system?.1.1.lagrangian Lagrangian mechanics is a reformulation of classical mechanics.

More information

Quantum mechanics in one hour

Quantum mechanics in one hour Chapter 2 Quantum mechanics in one hour 2.1 Introduction The purpose of this chapter is to refresh your knowledge of quantum mechanics and to establish notation. Depending on your background you might

More information

1 Fundamental physical postulates. C/CS/Phys C191 Quantum Mechanics in a Nutshell I 10/04/07 Fall 2007 Lecture 12

1 Fundamental physical postulates. C/CS/Phys C191 Quantum Mechanics in a Nutshell I 10/04/07 Fall 2007 Lecture 12 C/CS/Phys C191 Quantum Mechanics in a Nutshell I 10/04/07 Fall 2007 Lecture 12 In this and the next lecture we summarize the essential physical and mathematical aspects of quantum mechanics relevant to

More information

Outline Spherical symmetry Free particle Coulomb problem Keywords and References. Central potentials. Sourendu Gupta. TIFR, Mumbai, India

Outline Spherical symmetry Free particle Coulomb problem Keywords and References. Central potentials. Sourendu Gupta. TIFR, Mumbai, India Central potentials Sourendu Gupta TIFR, Mumbai, India Quantum Mechanics 1 2013 3 October, 2013 Outline 1 Outline 2 Rotationally invariant potentials 3 The free particle 4 The Coulomb problem 5 Keywords

More information

Approximation Methods in QM

Approximation Methods in QM Chapter 3 Approximation Methods in QM Contents 3.1 Time independent PT (nondegenerate)............... 5 3. Degenerate perturbation theory (PT)................. 59 3.3 Time dependent PT and Fermi s golden

More information

Quantum Physics II (8.05) Fall 2002 Assignment 12 and Study Aid

Quantum Physics II (8.05) Fall 2002 Assignment 12 and Study Aid Quantum Physics II (8.05) Fall 2002 Assignment 12 and Study Aid Announcement This handout includes 9 problems. The first 5 are the problem set due. The last 4 cover material from the final few lectures

More information

I. CSFs Are Used to Express the Full N-Electron Wavefunction

I. CSFs Are Used to Express the Full N-Electron Wavefunction Chapter 11 One Must be Able to Evaluate the Matrix Elements Among Properly Symmetry Adapted N- Electron Configuration Functions for Any Operator, the Electronic Hamiltonian in Particular. The Slater-Condon

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

6.1 Nondegenerate Perturbation Theory

6.1 Nondegenerate Perturbation Theory 6.1 Nondegenerate Perturbation Theory Analytic solutions to the Schrödinger equation have not been found for many interesting systems. Fortunately, it is often possible to find expressions which are analytic

More information

To make this point clear, let us rewrite the integral in a way that emphasizes its dependence on the momentum variable p:

To make this point clear, let us rewrite the integral in a way that emphasizes its dependence on the momentum variable p: 3.2 Construction of the path integral 101 To make this point clear, let us rewrite the integral in a way that emphasizes its dependence on the momentum variable p: q f e iĥt/ q i = Dq e i t 0 dt V (q)

More information

Stochastic series expansion (SSE) and ground-state projection

Stochastic series expansion (SSE) and ground-state projection Institute of Physics, Chinese Academy of Sciences, Beijing, October 31, 2014 Stochastic series expansion (SSE) and ground-state projection Anders W Sandvik, Boston University Review article on quantum

More information

11 Spinor solutions and CPT

11 Spinor solutions and CPT 11 Spinor solutions and CPT 184 In the previous chapter, we cataloged the irreducible representations of the Lorentz group O(1, 3. We found that in addition to the obvious tensor representations, φ, A

More information

Section 10: Many Particle Quantum Mechanics Solutions

Section 10: Many Particle Quantum Mechanics Solutions Physics 143a: Quantum Mechanics I Section 10: Many Particle Quantum Mechanics Solutions Spring 015, Harvard Here is a summary of the most important points from this week (with a few of my own tidbits),

More information

Attempts at relativistic QM

Attempts at relativistic QM Attempts at relativistic QM based on S-1 A proper description of particle physics should incorporate both quantum mechanics and special relativity. However historically combining quantum mechanics and

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

Angular momentum and spin

Angular momentum and spin Luleå tekniska universitet Avdelningen för Fysik, 007 Hans Weber Angular momentum and spin Angular momentum is a measure of how much rotation there is in particle or in a rigid body. In quantum mechanics

More information

Problem Set 2 Due Thursday, October 1, & & & & # % (b) Construct a representation using five d orbitals that sit on the origin as a basis:

Problem Set 2 Due Thursday, October 1, & & & & # % (b) Construct a representation using five d orbitals that sit on the origin as a basis: Problem Set 2 Due Thursday, October 1, 29 Problems from Cotton: Chapter 4: 4.6, 4.7; Chapter 6: 6.2, 6.4, 6.5 Additional problems: (1) Consider the D 3h point group and use a coordinate system wherein

More information

Lecture 19 (Nov. 15, 2017)

Lecture 19 (Nov. 15, 2017) Lecture 19 8.31 Quantum Theory I, Fall 017 8 Lecture 19 Nov. 15, 017) 19.1 Rotations Recall that rotations are transformations of the form x i R ij x j using Einstein summation notation), where R is an

More information

Shell model calculation ー from basics to the latest methods ー

Shell model calculation ー from basics to the latest methods ー Shell model calculation ー from basics to the latest methods ー Takahiro Mizusaki Senshu university / CNS, the univ. of Tokyo Basics What we will learn? What is Shell Model? Shell model basis states M-scheme

More information

1 Mathematical preliminaries

1 Mathematical preliminaries 1 Mathematical preliminaries The mathematical language of quantum mechanics is that of vector spaces and linear algebra. In this preliminary section, we will collect the various definitions and mathematical

More information

Physics 505 Homework No. 8 Solutions S Spinor rotations. Somewhat based on a problem in Schwabl.

Physics 505 Homework No. 8 Solutions S Spinor rotations. Somewhat based on a problem in Schwabl. Physics 505 Homework No 8 s S8- Spinor rotations Somewhat based on a problem in Schwabl a) Suppose n is a unit vector We are interested in n σ Show that n σ) = I where I is the identity matrix We will

More information

(a p (t)e i p x +a (t)e ip x p

(a p (t)e i p x +a (t)e ip x p 5/29/3 Lecture outline Reading: Zwiebach chapters and. Last time: quantize KG field, φ(t, x) = (a (t)e i x +a (t)e ip x V ). 2Ep H = ( ȧ ȧ(t)+ 2E 2 E pa a) = p > E p a a. P = a a. [a p,a k ] = δ p,k, [a

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

Quantum Physics III (8.06) Spring 2016 Assignment 3

Quantum Physics III (8.06) Spring 2016 Assignment 3 Quantum Physics III (8.6) Spring 6 Assignment 3 Readings Griffiths Chapter 9 on time-dependent perturbation theory Shankar Chapter 8 Cohen-Tannoudji, Chapter XIII. Problem Set 3. Semi-classical approximation

More information

arxiv:hep-lat/ v2 18 Jul 2006

arxiv:hep-lat/ v2 18 Jul 2006 The Effect of Reduced Spatial Symmetries on Lattice States: Results for Non-zero Linear Momentum David C. Moore, George T. Fleming arxiv:hep-lat/0607005v 8 Jul 006 Sloane Physics Laboratory, Yale University,

More information

Introduction to Modern Quantum Field Theory

Introduction to Modern Quantum Field Theory Department of Mathematics University of Texas at Arlington Arlington, TX USA Febuary, 2016 Recall Einstein s famous equation, E 2 = (Mc 2 ) 2 + (c p) 2, where c is the speed of light, M is the classical

More information

Group Representations

Group Representations Group Representations Alex Alemi November 5, 2012 Group Theory You ve been using it this whole time. Things I hope to cover And Introduction to Groups Representation theory Crystallagraphic Groups Continuous

More information

5 Topological insulator with time-reversal symmetry

5 Topological insulator with time-reversal symmetry Phys62.nb 63 5 Topological insulator with time-reversal symmetry It is impossible to have quantum Hall effect without breaking the time-reversal symmetry. xy xy. If we want xy to be invariant under, xy

More information

ν=0 Quantum Hall state in Bilayer graphene: collective modes

ν=0 Quantum Hall state in Bilayer graphene: collective modes ν= Quantum Hall state in Bilayer graphene: collective modes Bilayer graphene: Band structure Quantum Hall effect ν= state: Phase diagram Time-dependent Hartree-Fock approximation Neutral collective excitations

More information

Linear Algebra Section 2.6 : LU Decomposition Section 2.7 : Permutations and transposes Wednesday, February 13th Math 301 Week #4

Linear Algebra Section 2.6 : LU Decomposition Section 2.7 : Permutations and transposes Wednesday, February 13th Math 301 Week #4 Linear Algebra Section. : LU Decomposition Section. : Permutations and transposes Wednesday, February 1th Math 01 Week # 1 The LU Decomposition We learned last time that we can factor a invertible matrix

More information

Lecture 5. Hartree-Fock Theory. WS2010/11: Introduction to Nuclear and Particle Physics

Lecture 5. Hartree-Fock Theory. WS2010/11: Introduction to Nuclear and Particle Physics Lecture 5 Hartree-Fock Theory WS2010/11: Introduction to Nuclear and Particle Physics Particle-number representation: General formalism The simplest starting point for a many-body state is a system of

More information

Rigid Geometric Transformations

Rigid Geometric Transformations Rigid Geometric Transformations Carlo Tomasi This note is a quick refresher of the geometry of rigid transformations in three-dimensional space, expressed in Cartesian coordinates. 1 Cartesian Coordinates

More information

Quantum Theory of Angular Momentum and Atomic Structure

Quantum Theory of Angular Momentum and Atomic Structure Quantum Theory of Angular Momentum and Atomic Structure VBS/MRC Angular Momentum 0 Motivation...the questions Whence the periodic table? Concepts in Materials Science I VBS/MRC Angular Momentum 1 Motivation...the

More information

Lecture notes for QFT I (662)

Lecture notes for QFT I (662) Preprint typeset in JHEP style - PAPER VERSION Lecture notes for QFT I (66) Martin Kruczenski Department of Physics, Purdue University, 55 Northwestern Avenue, W. Lafayette, IN 47907-036. E-mail: markru@purdue.edu

More information

Quantum Monte Carlo Simulations in the Valence Bond Basis

Quantum Monte Carlo Simulations in the Valence Bond Basis NUMERICAL APPROACHES TO QUANTUM MANY-BODY SYSTEMS, IPAM, January 29, 2009 Quantum Monte Carlo Simulations in the Valence Bond Basis Anders W. Sandvik, Boston University Collaborators Kevin Beach (U. of

More information

Comparing and Improving Quark Models for the Triply Bottom Baryon Spectrum

Comparing and Improving Quark Models for the Triply Bottom Baryon Spectrum Comparing and Improving Quark Models for the Triply Bottom Baryon Spectrum A thesis submitted in partial fulfillment of the requirements for the degree of Bachelor of Science degree in Physics from the

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

The Dirac Field. Physics , Quantum Field Theory. October Michael Dine Department of Physics University of California, Santa Cruz

The Dirac Field. Physics , Quantum Field Theory. October Michael Dine Department of Physics University of California, Santa Cruz Michael Dine Department of Physics University of California, Santa Cruz October 2013 Lorentz Transformation Properties of the Dirac Field First, rotations. In ordinary quantum mechanics, ψ σ i ψ (1) is

More information

G : Quantum Mechanics II

G : Quantum Mechanics II G5.666: Quantum Mechanics II Notes for Lecture 7 I. A SIMPLE EXAMPLE OF ANGULAR MOMENTUM ADDITION Given two spin-/ angular momenta, S and S, we define S S S The problem is to find the eigenstates of the

More information

Block Lanczos Tridiagonalization of Complex Symmetric Matrices

Block Lanczos Tridiagonalization of Complex Symmetric Matrices Block Lanczos Tridiagonalization of Complex Symmetric Matrices Sanzheng Qiao, Guohong Liu, Wei Xu Department of Computing and Software, McMaster University, Hamilton, Ontario L8S 4L7 ABSTRACT The classic

More information

Degenerate Perturbation Theory

Degenerate Perturbation Theory Physics G6037 Professor Christ 12/05/2014 Degenerate Perturbation Theory The treatment of degenerate perturbation theory presented in class is written out here in detail. 1 General framework and strategy

More information

Automorphic Equivalence Within Gapped Phases

Automorphic Equivalence Within Gapped Phases 1 Harvard University May 18, 2011 Automorphic Equivalence Within Gapped Phases Robert Sims University of Arizona based on joint work with Sven Bachmann, Spyridon Michalakis, and Bruno Nachtergaele 2 Outline:

More information

The Linearized Augmented Planewave (LAPW) Method

The Linearized Augmented Planewave (LAPW) Method The Linearized Augmented Planewave (LAPW) Method David J. Singh Oak Ridge National Laboratory E T [ ]=T s [ ]+E ei [ ]+E H [ ]+E xc [ ]+E ii {T s +V ks [,r]} I (r)= i i (r) Need tools that are reliable

More information

Hückel Molecular orbital Theory Application PART III

Hückel Molecular orbital Theory Application PART III Subject PHYSICAL Paper No and Title TOPIC Sub-Topic (if any) 2, PHYSICAL -I QUANTUM Hückel Molecular orbital Theory Module No. 33 PAPER: 2, PHYSICAL -I TABLE OF CONTENTS 1. Learning outcomes 2. Hückel

More information

Time Independent Perturbation Theory

Time Independent Perturbation Theory apr_0-may_5.nb: 5/4/04::9:56:8 Time Independent Perturbation Theory Note: In producing a "final" vrsion of these notes I decided to change my notation from that used in class and by Sakurai. In class,

More information

Quantum Physics II (8.05) Fall 2002 Assignment 3

Quantum Physics II (8.05) Fall 2002 Assignment 3 Quantum Physics II (8.05) Fall 00 Assignment Readings The readings below will take you through the material for Problem Sets and 4. Cohen-Tannoudji Ch. II, III. Shankar Ch. 1 continues to be helpful. Sakurai

More information

Quantum Physics 2006/07

Quantum Physics 2006/07 Quantum Physics 6/7 Lecture 7: More on the Dirac Equation In the last lecture we showed that the Dirac equation for a free particle i h t ψr, t = i hc α + β mc ψr, t has plane wave solutions ψr, t = exp

More information