Electronic Structure

Size: px
Start display at page:

Download "Electronic Structure"

Transcription

1 Electronic Structure Exploration of the Tight Binding model for Graphene and the Anderson Model By Marco Santia Introduction Electronic Band structures describe the allowed energy ranges that an electron may have in a solid. To demonstrate Band Structure and how exactly it can be provide useful information to Solid-State physics, I will show a few well known models. The Tight Binding model is a well known model used to calculate band structures using sets of superpositioned wave functions for isolated atoms at each site in a lattice. As its name suggests, its a quantum mechanical model describing the properties of tightly bound electrons. To formulate the Tight Binding calculations, we must exploit the method of LCAO (Linear Combination of Atomic Orbitals) which will give us approximate solutions to the time-independent Schrodinger equations. However, the periodicity of the lattice tells us that the wave function can only change by a phase factor, therefore the LCAO approximation can be represented by the familiar Bloch wave. ψ(r + R l ) = e ik R l ψ(r) (1) The Bloch wave function is essentially where all of tight binding comes from, this will be shown in the first example of tight binding: Graphene. We will also demonstrate the tight binding model in the Anderson Model. Graphene Graphene is a very interesting case of tight binding to study, this is due to its abstract shape. Graphene is actually a material which just recently has collected a lot of attention, as it has defied previously thought laws of thermodynamics. We will be demonstrating with a honeycomb hexagonal shaped lattice of carbon atoms which means there will be two atoms per unit cell. This of course changes the approximation made from LCAO and thus the Bloch wave formulation. Generalized for two atoms per unit cell, Graphene s wave function can be modeled as follows: Ψ k I( r) = c A I ( k)ψ Ak I ( r) + c B I ( k)ψ Bk I ( r) = 1 N e i k Rj [c A I ( k)φ( r R A j ) + c B I ( k)φ( r R B j )], (2) j 1

2 here N is the number of elementary cells, and the functions φ( r) are the wave-functions of the p z orbitals of the carbon atoms. P z orbitals stay seperated from the rest of the orbitals in this structure and are responsible for the π and π bands which will be shown in the band structure plots. The remaining orbitals will form a hybridization sp 2 responsible for the σ-bonds 3. These are the bonds that keep nearest neighbors together in the lattice. Now to calculate band structure, we of course wish to find all the possible energies. For this we must derive a dispersion relation. To do so we must solve for a hamiltonian using the bloch wave functions shown previously. The Hamiltonian for this will already be in k-space due to the properties of the Bloch wave. It has already accounted for the fourier transformation of the wave function. This means the construction of the Hamiltonian (all hopping parameters t will be set to 1) will be all that is needed, this and of course to diagonalize the matrix and find the dispersion relations based on the energy eigenvalues of the Hamiltonian. This is found to be 1 : { } 1 E(k) = ±γ cos ( 3kx a 2 ) cos ( k ya 2 ) + 4 cos2 ( k ya 2 ) 2 (3) Where γ represents a parameter of the system, in my calculations I used a γ value of -2.7 ev. Using this dispersion relation, we can now plot the band structure using mathematica and analyze the physical relevance. This was done and the plots found are shown in FIG. 1. The lattice constant a was Å however, for simplicity, I generated values of ak y and ak x individually over the range [-4,4]. Analyzing this band structure, we see the honeycomb lattice as expected and we see the two bands. The upper band being the conduction band while the lower band is the valence band. The valence band consists of the energies for electrons that are bound to their cell while the conduction electrons can roam throughout the lattice structure. Notice the six points in which the bands are closest. These points are called dirac points, these points are when the electrons behave like relativistic particles described by the Dirac equation. Density of States was now calculated and graphed as well. This is an important parameter to graph as physical data is derived from the density of states for a structure. This can be seen on figure 2. The density of states here is very abstract, we notice two singularities, formally known as Van Hove signularities. The wavevectors at which Van Hove singularities occur are often referred to as critical points of the Brillouin zone. 2

3 FIG. 1: Energy Bands for Graphene dispersion with γ set to be 1 ev for simplicity. The upper band represents the π and the lower π. These determine the conduction and valence bands of the electrons in the lattice 2. Notice the six dirac points forming a hexagonal like shape just as the carbon structure for graphene is anticipated to. FIG. 2: Density of States plotted over energy. Multiple singularities are found, this is a large area of study in Solid-State Physics known as Van Hove singularities. Anderson Model We now evaluate a more simplistic case of Tight Binding. The case of a 2 dimensional square lattice where only nearest neighbor effects are needed. This is modeled by what is known as the Anderson Model 4 H = t i,j c i c j + ɛ i n i i 3

4 Where ɛ i the ramdomly generate site energy. Previously, we never considered a possible disorder energy at the site of the electron. Now we generate a random energy on the scale [-W/2,W/2] where W is equal to the disorder width. We will set this in the Fortran90 program I have written and alter it as needed for data analysis. The c i c j represent the creation and annhilation operators, just as in the quantum harmonic oscillator, these are ladder operators. C i represents annhilation, for example say we have a state 1, when the annhilation operator acts on such a state, it becomes a vacuum state. The same concept applies on a vacuum states in reverse when applying the creation operator. The number operator is represented by n i and it is the product of the creation and annhilation operators. Its value is one for our case. For this 2-D example, we will need to consider periodic boundary conditions. In its simplest form we can state the hamiltonian to be as follows: H ij = ψ i H ψ j (5) The 3x3 lattice example is shown below: ɛ i ɛ i ɛ i ɛ i ɛ i ɛ i ɛ i ɛ i ɛ i With this we can generate an entire matrix and then simply add the random energies along the diagonal. After diagonalization of this matrix, the energy eigenvalues will be output. The hamiltonian will have a 1 at every ij index that represents a nearest neighbor with the given periodic 4

5 FIG. 3: Density of states for Anderson model of a 40x40 lattice for different W compared with a histogram plotted in mathematica. conditions. This was all done in fortran90, refer to the subroutine neighbors on the attached code for the algorithm used. For efficiency, it was done without the use of any logical operators. The Hamiltonian was formulated and for a 3x3 lattice for example would be as shown above. We can see this matrix is symmetric, and in the case of our calculation, it will be sparse as well. Using a freely distributed algorithm from LAPACK (linear algebra library for fortran 77/90). This library contained subroutines that were able to output the eigenvalues and the eigenvectors of the input matrix. This was specifically designed for sparse, symmetric matrices which was the case for our hamiltonian. After finding the energy eigenvalues, we now find the density of states for multiple disorder widths W. This is shown below 4. We see a high level of consistency between the fortran code and the mathematica. The histogram produced was only for the original disorder width of W =.5. The mathematica and fortran codes are both included for reference. The last quantity calculated was the inverse partiticipation ratio. This is a ratio given by the sum of the squares of all the wave functions squared over the sum of the wave functions to the fourth. Thus the inverse participation ratio is related to the localization length 4. It is shown in the figure on the top of the next page. Conclusion Throughout all the calculations there was a high level of consistensy between fortran and mathematica. The band structures physical properties all corresponded to the ouput accurately. 5

6 FIG. 4: Inverse Participation Ratio averaged over all of the eigenvectors as a function of the disorder width W. The higher the disorder width, the lower the IPR, meaning the higher the disorder, the smaller the length of the localization is. Less will be localized as W increases. To further investigate this subject one could read more into the quantum hall effect and how it effects tight binding, Landau levels and the IPR and how exactly it effects the localization. 1 Pierre Delhas. Graphite and precursors. CRC Press, USA, Charles Kittel. Introduction to Solid-State Physics. Wiley-Interscience, USA, J. Maultzsch S. Reich and C. Thomsen. Tight-binding description of graphene. PHYSICAL REVIEW B, 6, D Weaire and C Hodges. Anderson localisation and the recursion method. J. Phys. C: Solid State Phys, 11(2),

7 File: /home/marco/desktop/project3/anderson/bind.f90 Page 1 of 3!Marco Santia!PHY480 Project 3 -- Tight Binding Model program tightbinding implicit none integer, allocatable, dimension(:,:) :: neighbors1, lattice real*8, allocatable, dimension(:,:) :: hamiltonian, eigenvectors, temp integer, allocatable, dimension(:) ::latticerow, latticecol real*8, allocatable, dimension(:) :: eigenvalues, ivpa integer n, L, x, j,m,i, n1(4),r real*8 ran, W, IPR, IPRa open(unit=37, status = 'replace', file="eigenvalues.dat") open(unit=40, status = 'replace', file="hamiltonian.csv") open(unit=23, file="dos2.dat") open(unit=30, file="ivp1.dat") open(unit=34, file="dosw.dat") call initialize() call random() do r=1,10 call setup() call diasym(temp,eigenvalues,l)!finds the eigenvalues of the matrix call DOS() call export() call IVP() write(30,*) W, IPRa W=W+.5 contains subroutine setup() hamiltonian(:,:) = 0.0 do i=1, L do j=1, 4 hamiltonian(i, neighbors1(i,j)) = 1.0 call random_number(ran) hamiltonian(i,i) = (ran*w)-(w/2) temp(:,:) = hamiltonian(:,:) end subroutine setup subroutine initialize() print*, "Size of Lattice: " read*, n L = n**2 W =.5d0 allocate(lattice(n,n)) allocate(latticerow(l)) allocate(latticecol(l)) allocate(ivpa(l)) allocate(eigenvalues(l)) allocate(neighbors1(l,4)) allocate(hamiltonian(l,l)) allocate(temp(l,l)) allocate(eigenvectors(l,l)) x = 1 do j=1, n do m=1, n lattice(j,m) = x latticecol(x) = m latticerow(x) = j x = x + 1 call neighbors()!call export() end subroutine initialize

8 File: /home/marco/desktop/project3/anderson/bind.f90 Page 2 of 3 subroutine export() do i=1, (L)!do j=1,l write(37,*) eigenvalues(i) write(40,*) int(hamiltonian(i,:)),','!!write(37,*) end subroutine export subroutine neighbors()!finds nearest neighbors for each point with the provided boundary conditions integer nleft,nright,nup,ndown, splice(n), col, row n1(:) = 0 do i=1, (L) n1(1)=modulo(i,l) + 1!nright n1(2)=(i+((-1*(modulo(1,i)-1))*(l)))-1!nleft col = latticecol(i) row = latticerow(i) splice = lattice(:,col) n1(3) = lattice((modulo(row,n) + 1),col)!ndown n1(4) = lattice(((row+((-1*(modulo(1,row)-1))*(n)))-1),col)!nup neighbors1(i,:) = n1(:) end subroutine neighbors subroutine DOS() integer :: bins=20 integer t, frequency(21) real*8 binwidth, emin, emax, e, avgf emax = eigenvalues(l) emin = eigenvalues(1) frequency(:) = 0 binwidth = abs((emax-emin)/dfloat(bins)) do i=1, L e = eigenvalues(i) + abs(emin) t = nint((e/(emax+abs(emin)))*dfloat(bins)) + 1 frequency(t) = frequency(t) + 1 do i=1, (bins+1) write(23,*) ((Dfloat(i)*binwidth)-binwidth-abs(emin)), frequency(i) avgf = sum(frequency)/21 write(34,*) w, avgf end subroutine DOS subroutine IVP() real*8 sum1,sum2 do j=1,l sum1 = 0.d0 sum2 = 0.d0 do i=1,l sum1 = sum1 + temp(j,i)**2 sum2 = sum2 + temp(j,i)**4 sum1 = sum1**2 IPR = sum1/(dfloat(l)*sum2) ivpa(j) = IPR IPRa = sum(ivpa)/dfloat(l) end subroutine IVP end program subroutine diasym(a,eig,n) implicit none integer n,l,inf real*8, dimension(n,n) :: a real*8 eig(n),work(n*(3+n/2))

9 File: /home/marco/desktop/project3/anderson/bind.f90 Page 3 of 3 l=n*(3+n/2) call dsyev('v','u',n,a,n,eig,work,l,inf)!call to LAPACK external linear algebra library, returns sorted eigenvalues end subroutine diasym

10 File: /home/marco/desktop/project3/graphene/dos.f90 Page 1 of 1 program DOS implicit none real*8, dimension( ) :: energies, k integer i,j,l real*8 akx,aky,a,pi open(unit=50, file="dosgraph.dat") l=1 a = pi = d0 akx = do i=1,5000 aky = do j=1,5000 energies(l) = sqrt(1+4.d0*cos(sqrt(3.d0)*(aky)*.5)*cos((akx)*.5)+ 4.d0*cos((akx)*.5)**2) energies(l+1) = -sqrt(1+4.d0*cos(sqrt(3.d0)*(aky)*.5)*cos((akx)*.5)+ 4.d0*cos((akx)*.5) **2) aky = aky + 1 l = l+2 akx = akx + 1 call Density() contains subroutine Density() integer :: bins=1000 integer t, frequency(2001) real*8 binwidth, emin, emax, e emax = MAXVAL(energies) emin = MINVAL(energies) frequency(:) = 0 binwidth = abs((emax-emin)/dfloat(bins)) do i=1, L e = energies(i) + abs(emin) t = nint((e/(emax+abs(emin)))*dfloat(bins)) + 1 frequency(t) = frequency(t) + 1 do i=1, (bins+1) write(50,*) ((Dfloat(i)*binwidth)-binwidth-abs(emin)), frequency(i) end subroutine Density end program DOS

11 vbands Sqrt 1 4 Cos cbands Sqrt 1 4 Cos 3 aky.5 Cos akx.5 4 Cos akx.5 ^2 ; 3 aky.5 Cos akx.5 4 Cos akx.5 ^2 ; Plot3D cbands, vbands, akx, 5, 5, aky, 5, 5, PlotPoints 50, Mesh None

12 2 Energy Dispersion.nb

Refering to Fig. 1 the lattice vectors can be written as: ~a 2 = a 0. We start with the following Ansatz for the wavefunction:

Refering to Fig. 1 the lattice vectors can be written as: ~a 2 = a 0. We start with the following Ansatz for the wavefunction: 1 INTRODUCTION 1 Bandstructure of Graphene and Carbon Nanotubes: An Exercise in Condensed Matter Physics developed by Christian Schönenberger, April 1 Introduction This is an example for the application

More information

structure of graphene and carbon nanotubes which forms the basis for many of their proposed applications in electronics.

structure of graphene and carbon nanotubes which forms the basis for many of their proposed applications in electronics. Chapter Basics of graphene and carbon nanotubes This chapter reviews the theoretical understanding of the geometrical and electronic structure of graphene and carbon nanotubes which forms the basis for

More information

arxiv: v1 [cond-mat.mes-hall] 1 Nov 2011

arxiv: v1 [cond-mat.mes-hall] 1 Nov 2011 V The next nearest neighbor effect on the D materials properties Maher Ahmed Department of Physics and Astronomy, University of Western Ontario, London ON N6A K7, Canada and arxiv:.v [cond-mat.mes-hall]

More information

Quantum Oscillations in Graphene in the Presence of Disorder

Quantum Oscillations in Graphene in the Presence of Disorder WDS'9 Proceedings of Contributed Papers, Part III, 97, 9. ISBN 978-8-778-- MATFYZPRESS Quantum Oscillations in Graphene in the Presence of Disorder D. Iablonskyi Taras Shevchenko National University of

More information

Quantum Condensed Matter Physics

Quantum Condensed Matter Physics QCMP-2017/18 Problem sheet 2: Quantum Condensed Matter Physics Band structure 1. Optical absorption of simple metals Sketch the typical energy-wavevector dependence, or dispersion relation, of electrons

More information

Graphene and Planar Dirac Equation

Graphene and Planar Dirac Equation Graphene and Planar Dirac Equation Marina de la Torre Mayado 2016 Marina de la Torre Mayado Graphene and Planar Dirac Equation June 2016 1 / 48 Outline 1 Introduction 2 The Dirac Model Tight-binding model

More information

Electrons in a periodic potential

Electrons in a periodic potential Chapter 3 Electrons in a periodic potential 3.1 Bloch s theorem. We consider in this chapter electrons under the influence of a static, periodic potential V (x), i.e. such that it fulfills V (x) = V (x

More information

Physics 211B : Problem Set #0

Physics 211B : Problem Set #0 Physics 211B : Problem Set #0 These problems provide a cross section of the sort of exercises I would have assigned had I taught 211A. Please take a look at all the problems, and turn in problems 1, 4,

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

ELECTRONIC ENERGY DISPERSION AND STRUCTURAL PROPERTIES ON GRAPHENE AND CARBON NANOTUBES

ELECTRONIC ENERGY DISPERSION AND STRUCTURAL PROPERTIES ON GRAPHENE AND CARBON NANOTUBES ELECTRONIC ENERGY DISPERSION AND STRUCTURAL PROPERTIES ON GRAPHENE AND CARBON NANOTUBES D. RACOLTA, C. ANDRONACHE, D. TODORAN, R. TODORAN Technical University of Cluj Napoca, North University Center of

More information

Physics 541: Condensed Matter Physics

Physics 541: Condensed Matter Physics Physics 541: Condensed Matter Physics Final Exam Monday, December 17, 2012 / 14:00 17:00 / CCIS 4-285 Student s Name: Instructions There are 24 questions. You should attempt all of them. Mark your response

More information

ECE 535 Theory of Semiconductors and Semiconductor Devices Fall 2015 Homework # 5 Due Date: 11/17/2015

ECE 535 Theory of Semiconductors and Semiconductor Devices Fall 2015 Homework # 5 Due Date: 11/17/2015 ECE 535 Theory of Semiconductors and Semiconductor Devices Fall 2015 Homework # 5 Due Date: 11/17/2015 Problem # 1 Two carbon atoms and four hydrogen atoms form and ethane molecule with the chemical formula

More information

Lecture contents. A few concepts from Quantum Mechanics. Tight-binding model Solid state physics review

Lecture contents. A few concepts from Quantum Mechanics. Tight-binding model Solid state physics review Lecture contents A few concepts from Quantum Mechanics Particle in a well Two wells: QM perturbation theory Many wells (atoms) BAND formation Tight-binding model Solid state physics review Approximations

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

Carbon nanotubes: Models, correlations and the local density of states

Carbon nanotubes: Models, correlations and the local density of states Carbon nanotubes: Models, correlations and the local density of states Alexander Struck in collaboration with Sebastián A. Reyes Sebastian Eggert 15. 03. 2010 Outline Carbon structures Modelling of a carbon

More information

3-month progress Report

3-month progress Report 3-month progress Report Graphene Devices and Circuits Supervisor Dr. P.A Childs Table of Content Abstract... 1 1. Introduction... 1 1.1 Graphene gold rush... 1 1.2 Properties of graphene... 3 1.3 Semiconductor

More information

Lecture 6. Tight-binding model

Lecture 6. Tight-binding model Lecture 6 Tight-binding model In Lecture 3 we discussed the Krönig-Penny model and we have seen that, depending on the strength of the potential barrier inside the unit cell, the electrons can behave like

More information

ELECTRONIC PROPERTIES OF GRAPHENE NANO STRUCTURES A THESIS SUBMITTED TO THE GRADUATE SCHOOL IN PARTIAL FULFILLMENT OF THE REQUIREMENTS FOR THE DEGREE

ELECTRONIC PROPERTIES OF GRAPHENE NANO STRUCTURES A THESIS SUBMITTED TO THE GRADUATE SCHOOL IN PARTIAL FULFILLMENT OF THE REQUIREMENTS FOR THE DEGREE ELECTRONIC PROPERTIES OF GRAPHENE NANO STRUCTURES A THESIS SUBMITTED TO THE GRADUATE SCHOOL IN PARTIAL FULFILLMENT OF THE REQUIREMENTS FOR THE DEGREE MASTER OF SCIENCE BY SPENCER JONES ADVISOR: DR. MAHFUZA

More information

Quantum Condensed Matter Physics Lecture 9

Quantum Condensed Matter Physics Lecture 9 Quantum Condensed Matter Physics Lecture 9 David Ritchie QCMP Lent/Easter 2018 http://www.sp.phy.cam.ac.uk/drp2/home 9.1 Quantum Condensed Matter Physics 1. Classical and Semi-classical models for electrons

More information

From graphene to graphite: Electronic structure around the K point

From graphene to graphite: Electronic structure around the K point PHYSICL REVIEW 74, 075404 2006 From graphene to graphite: Electronic structure around the K point. Partoens* and F. M. Peeters Universiteit ntwerpen, Departement Fysica, Groenenborgerlaan 171, -2020 ntwerpen,

More information

Carbon nanotubes and Graphene

Carbon nanotubes and Graphene 16 October, 2008 Solid State Physics Seminar Main points 1 History and discovery of Graphene and Carbon nanotubes 2 Tight-binding approximation Dynamics of electrons near the Dirac-points 3 Properties

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

Three Most Important Topics (MIT) Today

Three Most Important Topics (MIT) Today Three Most Important Topics (MIT) Today Electrons in periodic potential Energy gap nearly free electron Bloch Theorem Energy gap tight binding Chapter 1 1 Electrons in Periodic Potential We now know the

More information

Chm 331 Fall 2015, Exercise Set 4 NMR Review Problems

Chm 331 Fall 2015, Exercise Set 4 NMR Review Problems Chm 331 Fall 015, Exercise Set 4 NMR Review Problems Mr. Linck Version.0. Compiled December 1, 015 at 11:04:44 4.1 Diagonal Matrix Elements for the nmr H 0 Find the diagonal matrix elements for H 0 (the

More information

POEM: Physics of Emergent Materials

POEM: Physics of Emergent Materials POEM: Physics of Emergent Materials Nandini Trivedi L1: Spin Orbit Coupling L2: Topology and Topological Insulators Reference: Bernevig Topological Insulators and Topological Superconductors Tutorials:

More information

Theoretical Concepts of Spin-Orbit Splitting

Theoretical Concepts of Spin-Orbit Splitting Chapter 9 Theoretical Concepts of Spin-Orbit Splitting 9.1 Free-electron model In order to understand the basic origin of spin-orbit coupling at the surface of a crystal, it is a natural starting point

More information

Floquet Topological Insulator:

Floquet Topological Insulator: Floquet Topological Insulator: Understanding Floquet topological insulator in semiconductor quantum wells by Lindner et al. Condensed Matter Journal Club Caltech February 12 2014 Motivation Motivation

More information

Lecture 4: Basic elements of band theory

Lecture 4: Basic elements of band theory Phys 769 Selected Topics in Condensed Matter Physics Summer 010 Lecture 4: Basic elements of band theory Lecturer: Anthony J. Leggett TA: Bill Coish 1 Introduction Most matter, in particular most insulating

More information

Energy bands in two limits

Energy bands in two limits M. A. Gusmão IF-UFRGS 1 FIP10601 Text 4 Energy bands in two limits After presenting a general view of the independent-electron approximation, highlighting the importance and consequences of Bloch s theorem,

More information

Homework 2 - Solutions

Homework 2 - Solutions Homework 2 - Solutions Carbon Nanotubes Part 4) We can write the wavefunction of the grahene sheet within the tight-binding model in the usual way ( ~ R)= e i~ k ~R Then, to imose eriodic boundary condition

More information

arxiv: v1 [cond-mat.mes-hall] 22 May 2012

arxiv: v1 [cond-mat.mes-hall] 22 May 2012 1 arxiv:1205.4849v1 [cond-mat.mes-hall] 22 May 2012 Electronic properties of monolayer and bilayer graphene Edward Mcann Department of Physics, Lancaster University, Lancaster, L1 4YB, United Kingdom ed.mccann@lancaster.ac.uk

More information

Calculation of Cutting Lines of Single-Walled Carbon Nanotubes

Calculation of Cutting Lines of Single-Walled Carbon Nanotubes 65 C.Ü. Fen Fakültesi Fen Bilimleri Dergisi, Cilt 33, No. 1 (2012) Calculation of Cutting Lines of Single-Walled Carbon Nanotubes Erdem UZUN 1* 1 Karamanoğlu Mehmetbey Üniversitesi, Fen Fakültesi, Fizik

More information

An Extended Hückel Theory based Atomistic Model for Graphene Nanoelectronics

An Extended Hückel Theory based Atomistic Model for Graphene Nanoelectronics Journal of Computational Electronics X: YYY-ZZZ,? 6 Springer Science Business Media, Inc. Manufactured in The Netherlands An Extended Hückel Theory based Atomistic Model for Graphene Nanoelectronics HASSAN

More information

Introduction to Condensed Matter Physics

Introduction to Condensed Matter Physics Introduction to Condensed Matter Physics The Reciprocal Lattice M.P. Vaughan Overview Overview of the reciprocal lattice Periodic functions Reciprocal lattice vectors Bloch functions k-space Dispersion

More information

From Graphene to Nanotubes

From Graphene to Nanotubes From Graphene to Nanotubes Zone Folding and Quantum Confinement at the Example of the Electronic Band Structure Christian Krumnow christian.krumnow@fu-berlin.de Freie Universität Berlin June 6, Zone folding

More information

Tight-Binding Approximation. Faculty of Physics UW

Tight-Binding Approximation. Faculty of Physics UW Tight-Binding Approximation Faculty of Physics UW Jacek.Szczytko@fuw.edu.pl The band theory of solids. 2017-06-05 2 Periodic potential Bloch theorem φ n,k Ԧr = u n,k Ԧr eik Ԧr Bloch wave, Bloch function

More information

Remarks on the tight-binding model of graphene

Remarks on the tight-binding model of graphene Remarks on the tight-binding model of graphene arxiv:712.765v1 [cond-mat.mes-hall] 5 Dec 27 Cristina Bena 1,2, Gilles Montambaux 2 1 Service de Physique Théorique, CEA/Saclay, Orme des Merisiers, 9119

More information

Energy dispersion relations for holes inn silicon quantum wells and quantum wires

Energy dispersion relations for holes inn silicon quantum wells and quantum wires Purdue University Purdue e-pubs Other Nanotechnology Publications Birck Nanotechnology Center 6--7 Energy dispersion relations for holes inn silicon quantum wells and quantum wires Vladimir Mitin Nizami

More information

Beautiful Graphene, Photonic Crystals, Schrödinger and Dirac Billiards and Their Spectral Properties

Beautiful Graphene, Photonic Crystals, Schrödinger and Dirac Billiards and Their Spectral Properties Beautiful Graphene, Photonic Crystals, Schrödinger and Dirac Billiards and Their Spectral Properties Cocoyoc 2012 Something about graphene and microwave billiards Dirac spectrum in a photonic crystal Experimental

More information

Spins and spin-orbit coupling in semiconductors, metals, and nanostructures

Spins and spin-orbit coupling in semiconductors, metals, and nanostructures B. Halperin Spin lecture 1 Spins and spin-orbit coupling in semiconductors, metals, and nanostructures Behavior of non-equilibrium spin populations. Spin relaxation and spin transport. How does one produce

More information

Electrons in periodic potential

Electrons in periodic potential Chapter 9 Electrons in periodic potential The computation of electronic states in a solid is a nontrivial problem. A great simplification can be achieved if the solid is a crystal, i.e. if it can be described

More information

Conductance of Graphene Nanoribbon Junctions and the Tight Binding Model

Conductance of Graphene Nanoribbon Junctions and the Tight Binding Model Wu and Childs Nanoscale es Lett, 6:6 http://www.nanoscalereslett.com/content/6//6 NANO EXPE Open Access Conductance of Graphene Nanoribbon Junctions and the Tight Binding Model Y Wu, PA Childs * Abstract

More information

arxiv: v1 [cond-mat.str-el] 11 Nov 2013

arxiv: v1 [cond-mat.str-el] 11 Nov 2013 arxiv:1311.2420v1 [cond-mat.str-el] 11 Nov 2013 Monte-Carlo simulation of graphene in terms of occupation numbers for the ecitonic order parameter at heagonal lattice. Institute for Theoretical Problems

More information

Supersymmetry and Quantum Hall effect in graphene

Supersymmetry and Quantum Hall effect in graphene Supersymmetry and Quantum Hall effect in graphene Ervand Kandelaki Lehrstuhl für Theoretische Festköperphysik Institut für Theoretische Physik IV Universität Erlangen-Nürnberg March 14, 007 1 Introduction

More information

Solution to Exercise 2

Solution to Exercise 2 Department of physics, NTNU TFY Mesoscopic Physics Spring Solution to xercise Question Apart from an adjustable constant, the nearest neighbour nn) tight binding TB) band structure for the D triangular

More information

3.14. The model of Haldane on a honeycomb lattice

3.14. The model of Haldane on a honeycomb lattice 4 Phys60.n..7. Marginal case: 4 t Dirac points at k=(,). Not an insulator. No topological index...8. case IV: 4 t All the four special points has z 0. We just use u I for the whole BZ. No singularity.

More information

Graphite, graphene and relativistic electrons

Graphite, graphene and relativistic electrons Graphite, graphene and relativistic electrons Introduction Physics of E. graphene Y. Andrei Experiments Rutgers University Transport electric field effect Quantum Hall Effect chiral fermions STM Dirac

More information

Numerical construction of Wannier functions

Numerical construction of Wannier functions July 12, 2017 Internship Tutor: A. Levitt School Tutor: É. Cancès 1/27 Introduction Context: Describe electrical properties of crystals (insulator, conductor, semi-conductor). Applications in electronics

More information

Lecture 26: Qualitative Molecular Orbital Theory: Hückel Theory

Lecture 26: Qualitative Molecular Orbital Theory: Hückel Theory MASSACHUSETTS INSTITUTE OF TECHNOLOGY 5.6 Physical Chemistry I Fall, 07 Professor Robert W. Field Lecture 6: Qualitative Molecular Orbital Theory: Hückel Theory Models in Physical Chemistry Our job is

More information

Nanoscience quantum transport

Nanoscience quantum transport Nanoscience quantum transport Janine Splettstößer Applied Quantum Physics, MC2, Chalmers University of Technology Chalmers, November 2 10 Plan/Outline 4 Lectures (1) Introduction to quantum transport (2)

More information

ECE 659, PRACTICE EXAM II Actual Exam Friday, Feb.21, 2014, FNY B124, PM CLOSED BOOK. = H nm. Actual Exam will have five questions.

ECE 659, PRACTICE EXAM II Actual Exam Friday, Feb.21, 2014, FNY B124, PM CLOSED BOOK. = H nm. Actual Exam will have five questions. 1 ECE 659, PRACTICE EXAM II Actual Exam Friday, Feb.1, 014, FNY B14, 330-40PM CLOSED BOOK Useful relation h( k ) = H nm [ ] e +i k.( r m r n ) Actual Exam will have five questions. The following questions

More information

Quantum mechanics can be used to calculate any property of a molecule. The energy E of a wavefunction Ψ evaluated for the Hamiltonian H is,

Quantum mechanics can be used to calculate any property of a molecule. The energy E of a wavefunction Ψ evaluated for the Hamiltonian H is, Chapter : Molecules Quantum mechanics can be used to calculate any property of a molecule The energy E of a wavefunction Ψ evaluated for the Hamiltonian H is, E = Ψ H Ψ Ψ Ψ 1) At first this seems like

More information

Graphene-like microwave billiards: Van-Hove singularities and Excited-State Quantum Phase Transitions

Graphene-like microwave billiards: Van-Hove singularities and Excited-State Quantum Phase Transitions Graphene-like microwave billiards: Van-Hove singularities and Excited-State Quantum Phase Transitions Michal Macek Sloane Physics Laboratory, Yale University in collaboration with: Francesco Iachello (Yale)

More information

Berry s phase in Hall Effects and Topological Insulators

Berry s phase in Hall Effects and Topological Insulators Lecture 6 Berry s phase in Hall Effects and Topological Insulators Given the analogs between Berry s phase and vector potentials, it is not surprising that Berry s phase can be important in the Hall effect.

More information

Bonding in solids The interaction of electrons in neighboring atoms of a solid serves the very important function of holding the crystal together.

Bonding in solids The interaction of electrons in neighboring atoms of a solid serves the very important function of holding the crystal together. Bonding in solids The interaction of electrons in neighboring atoms of a solid serves the very important function of holding the crystal together. For example Nacl In the Nacl lattice, each Na atom is

More information

P3317 HW from Lecture and Recitation 10

P3317 HW from Lecture and Recitation 10 P3317 HW from Lecture 18+19 and Recitation 10 Due Nov 6, 2018 Problem 1. Equipartition Note: This is a problem from classical statistical mechanics. We will need the answer for the next few problems, and

More information

HW#6 (Bandstructure) and DOS

HW#6 (Bandstructure) and DOS HW#6 (Bandstructure) and DOS Problem 1. The textbook works out the bandstructure for GaAs. Let us do it for silicon. Notice that both cation and anion are Si atoms. Plot the bandstructure along the L-Γ-X

More information

Energy Spectrum of the Electrons in Graphene

Energy Spectrum of the Electrons in Graphene Energy Spectrum of the Electrons in Graphene Bachelor Thesis at the Institute for Theoretical Physics, Albert Einstein Center for Fundamental Physics, University of Bern by Carla Gross July Supervisor:

More information

Edge states in strained honeycomb lattices : a microwave experiment

Edge states in strained honeycomb lattices : a microwave experiment Edge states in strained honeycomb lattices : a microwave experiment Matthieu Bellec 1, Ulrich Kuhl 1, Gilles Montambaux 2 and Fabrice Mortessagne 1 1 Laboratoire de Physique de la Matière Condensée, CNRS

More information

Tight-binding models tight-binding models. Phys540.nb Example 1: a one-band model

Tight-binding models tight-binding models. Phys540.nb Example 1: a one-band model Phys540.nb 77 6 Tight-binding models 6.. tight-binding models Tight-binding models are effective tools to describe the motion of electrons in solids. Here, we assume that the system is a discrete lattice

More information

Tight binding models from band representations

Tight binding models from band representations Tight binding models from band representations Jennifer Cano Stony Brook University and Flatiron Institute for Computational Quantum Physics Part 0: Review of band representations BANDREP http://www.cryst.ehu.es/cgi-bin/cryst/programs/bandrep.pl

More information

Electronic Structure of Surfaces

Electronic Structure of Surfaces Electronic Structure of Surfaces When solids made of an infinite number of atoms are formed, it is a common misconception to consider each atom individually. Rather, we must consider the structure of the

More information

THE ELECTRON-PHONON MATRIX ELEMENT IN THE DIRAC POINT OF GRAPHENE

THE ELECTRON-PHONON MATRIX ELEMENT IN THE DIRAC POINT OF GRAPHENE NANOSYSTEMS: PHYSICS, CHEMISTRY, MATHEMATICS, 2014, 5 (1), P. 142 147 THE ELECTRON-PHONON MATRIX ELEMENT IN THE DIRAC POINT OF GRAPHENE 1,2 S. V. Koniakhin, 1,2,3 E. D. Eidelman 1 Ioffe Physical-Technical

More information

Topological Properties of Quantum States of Condensed Matter: some recent surprises.

Topological Properties of Quantum States of Condensed Matter: some recent surprises. Topological Properties of Quantum States of Condensed Matter: some recent surprises. F. D. M. Haldane Princeton University and Instituut Lorentz 1. Berry phases, zero-field Hall effect, and one-way light

More information

Strongly correlated systems in atomic and condensed matter physics. Lecture notes for Physics 284 by Eugene Demler Harvard University

Strongly correlated systems in atomic and condensed matter physics. Lecture notes for Physics 284 by Eugene Demler Harvard University Strongly correlated systems in atomic and condensed matter physics Lecture notes for Physics 284 by Eugene Demler Harvard University September 18, 2014 2 Chapter 5 Atoms in optical lattices Optical lattices

More information

GaAs -- MLWF. Special thanks to Elias Assmann (TU Graz) for the generous help in preparation of this tutorial

GaAs -- MLWF. Special thanks to Elias Assmann (TU Graz) for the generous help in preparation of this tutorial GaAs -- MLWF + + Special thanks to Elias Assmann (TU Graz) for the generous help in preparation of this tutorial YouTube video: https://youtu.be/r4c1yhdh3ge 1. Wien2k SCF Create a tutorial directory, e.g.

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

Two-phonon Raman scattering in graphene for laser excitation beyond the π-plasmon energy

Two-phonon Raman scattering in graphene for laser excitation beyond the π-plasmon energy Journal of Physics: Conference Series PAPER OPEN ACCESS Two-phonon Raman scattering in graphene for laser excitation beyond the π-plasmon energy To cite this article: Valentin N Popov 2016 J. Phys.: Conf.

More information

arxiv: v1 [cond-mat.str-el] 18 Jul 2007

arxiv: v1 [cond-mat.str-el] 18 Jul 2007 arxiv:0707.2704v1 [cond-mat.str-el] 18 Jul 2007 Determination of the Mott insulating transition by the multi-reference density functional theory 1. Introduction K. Kusakabe Graduate School of Engineering

More information

GRAPHENE the first 2D crystal lattice

GRAPHENE the first 2D crystal lattice GRAPHENE the first 2D crystal lattice dimensionality of carbon diamond, graphite GRAPHENE realized in 2004 (Novoselov, Science 306, 2004) carbon nanotubes fullerenes, buckyballs what s so special about

More information

Electron levels in a periodic potential: general remarks. Daniele Toffoli January 11, / 46

Electron levels in a periodic potential: general remarks. Daniele Toffoli January 11, / 46 Electron levels in a periodic potential: general remarks Daniele Toffoli January 11, 2017 1 / 46 Outline 1 Mathematical tools 2 The periodic potential 3 Bloch s theorem and Born-von Karman boundary conditions

More information

arxiv:physics/ v2 [physics.atom-ph] 31 May 2004

arxiv:physics/ v2 [physics.atom-ph] 31 May 2004 arxiv:physics/0405136v2 [physics.atom-ph] 31 May 2004 Pure spin angular momentum coefficients for non scalar one particle operators in jj coupling G. Gaigalas a and S. Fritzsche b a Institute of Theoretical

More information

Luttinger Liquid at the Edge of a Graphene Vacuum

Luttinger Liquid at the Edge of a Graphene Vacuum Luttinger Liquid at the Edge of a Graphene Vacuum H.A. Fertig, Indiana University Luis Brey, CSIC, Madrid I. Introduction: Graphene Edge States (Non-Interacting) II. III. Quantum Hall Ferromagnetism and

More information

Dirac semimetal in three dimensions

Dirac semimetal in three dimensions Dirac semimetal in three dimensions Steve M. Young, Saad Zaheer, Jeffrey C. Y. Teo, Charles L. Kane, Eugene J. Mele, and Andrew M. Rappe University of Pennsylvania 6/7/12 1 Dirac points in Graphene Without

More information

The Quantum Spin Hall Effect

The Quantum Spin Hall Effect The Quantum Spin Hall Effect Shou-Cheng Zhang Stanford University with Andrei Bernevig, Taylor Hughes Science, 314,1757 2006 Molenamp et al, Science, 318, 766 2007 XL Qi, T. Hughes, SCZ preprint The quantum

More information

Tight binding and emergence of "Dirac" equation in graphene.

Tight binding and emergence of Dirac equation in graphene. Tight binding and emergence of "Dirac" equation in graphene. A. A. Kozhevnikov 1 1 Laboratory of Theoretical Physics, S. L. Sobolev Institute for Mathematics, and Novosibirsk State University April 22,

More information

SUPPLEMENTARY INFORMATION

SUPPLEMENTARY INFORMATION In the format provided by the authors and unedited. DOI: 10.1038/NPHYS4080 Topological states in engineered atomic lattices Robert Drost, Teemu Ojanen, Ari Harju, and Peter Liljeroth Department of Applied

More information

Numerical Linear Algebra

Numerical Linear Algebra Numerical Linear Algebra By: David McQuilling; Jesus Caban Deng Li Jan.,31,006 CS51 Solving Linear Equations u + v = 8 4u + 9v = 1 A x b 4 9 u v = 8 1 Gaussian Elimination Start with the matrix representation

More information

Carbon Nanotubes (CNTs)

Carbon Nanotubes (CNTs) Carbon Nanotubes (s) Seminar: Quantendynamik in mesoskopischen Systemen Florian Figge Fakultät für Physik Albert-Ludwigs-Universität Freiburg July 7th, 2010 F. Figge (University of Freiburg) Carbon Nanotubes

More information

Quantum Mechanics II

Quantum Mechanics II Quantum Mechanics II Prof. Boris Altshuler March 8, 011 1 Lecture 19 1.1 Second Quantization Recall our results from simple harmonic oscillator. We know the Hamiltonian very well so no need to repeat here.

More information

Lattice simulation of tight-binding theory of graphene with partially screened Coulomb interactions

Lattice simulation of tight-binding theory of graphene with partially screened Coulomb interactions Lattice simulation of tight-binding theory of graphene with partially screened Coulomb interactions Dominik Smith Lorenz von Smekal smith@theorie.ikp.physik.tu-darmstadt.de 1. August 2013 IKP TUD / SFB

More information

Robustness of edge states in graphene quantum dots

Robustness of edge states in graphene quantum dots Chapter 5 Robustness of edge states in graphene quantum dots 5.1 Introduction The experimental discovery of graphene [3, 57], a monolayer of carbon atoms, has opened room for new electronic devices (for

More information

Effective theory of quadratic degeneracies

Effective theory of quadratic degeneracies Effective theory of quadratic degeneracies Y. D. Chong,* Xiao-Gang Wen, and Marin Soljačić Department of Physics, Massachusetts Institute of Technology, Cambridge, Massachusetts 02139, USA Received 28

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

Physics 541: Condensed Matter Physics

Physics 541: Condensed Matter Physics Physics 541: Condensed Matter Physics In-class Midterm Exam Wednesday, October 26, 2011 / 14:00 15:20 / CCIS 4-285 Student s Name: Instructions There are 23 questions. You should attempt all of them. Mark

More information

Topological Physics in Band Insulators II

Topological Physics in Band Insulators II Topological Physics in Band Insulators II Gene Mele University of Pennsylvania Topological Insulators in Two and Three Dimensions The canonical list of electric forms of matter is actually incomplete Conductor

More information

Electrons in Crystals. Chris J. Pickard

Electrons in Crystals. Chris J. Pickard Electrons in Crystals Chris J. Pickard Electrons in Crystals The electrons in a crystal experience a potential with the periodicity of the Bravais lattice: U(r + R) = U(r) The scale of the periodicity

More information

where a is the lattice constant of the triangular Bravais lattice. reciprocal space is spanned by

where a is the lattice constant of the triangular Bravais lattice. reciprocal space is spanned by Contents 5 Topological States of Matter 1 5.1 Intro.......................................... 1 5.2 Integer Quantum Hall Effect..................... 1 5.3 Graphene......................................

More information

STM spectra of graphene

STM spectra of graphene STM spectra of graphene K. Sengupta Theoretical Physics Division, IACS, Kolkata. Collaborators G. Baskaran, I.M.Sc Chennai, K. Saha, IACS Kolkata I. Paul, Grenoble France H. Manoharan, Stanford USA Refs:

More information

Nearly Free Electron Gas model - I

Nearly Free Electron Gas model - I Nearly Free Electron Gas model - I Contents 1 Free electron gas model summary 1 2 Electron effective mass 3 2.1 FEG model for sodium...................... 4 3 Nearly free electron model 5 3.1 Primitive

More information

SUPPLEMENTARY INFORMATION

SUPPLEMENTARY INFORMATION doi:10.1038/nature10941 1. Motivation and summary of results. In this work we combine a central tenet of condensed matter physics how electronic band structure emerges from a periodic potential in a crystal

More information

Application of the Lanczos Algorithm to Anderson Localization

Application of the Lanczos Algorithm to Anderson Localization Application of the Lanczos Algorithm to Anderson Localization Adam Anderson The University of Chicago UW REU 2009 Advisor: David Thouless Effect of Impurities in Materials Naively, one might expect that

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

Lecture 15 From molecules to solids

Lecture 15 From molecules to solids Lecture 15 From molecules to solids Background In the last two lectures, we explored quantum mechanics of multi-electron atoms the subject of atomic physics. In this lecture, we will explore how these

More information

Quantum Condensed Matter Physics Lecture 4

Quantum Condensed Matter Physics Lecture 4 Quantum Condensed Matter Physics Lecture 4 David Ritchie QCMP Lent/Easter 2019 http://www.sp.phy.cam.ac.uk/drp2/home 4.1 Quantum Condensed Matter Physics 1. Classical and Semi-classical models for electrons

More information

Correlated Phases of Bosons in the Flat Lowest Band of the Dice Lattice

Correlated Phases of Bosons in the Flat Lowest Band of the Dice Lattice Correlated Phases of Bosons in the Flat Lowest Band of the Dice Lattice Gunnar Möller & Nigel R Cooper Cavendish Laboratory, University of Cambridge Physical Review Letters 108, 043506 (2012) LPTHE / LPTMC

More information

Supplementary Figure S1. STM image of monolayer graphene grown on Rh (111). The lattice

Supplementary Figure S1. STM image of monolayer graphene grown on Rh (111). The lattice Supplementary Figure S1. STM image of monolayer graphene grown on Rh (111). The lattice mismatch between graphene (0.246 nm) and Rh (111) (0.269 nm) leads to hexagonal moiré superstructures with the expected

More information

Angular Momentum Algebra

Angular Momentum Algebra Angular Momentum Algebra Chris Clark August 1, 2006 1 Input We will be going through the derivation of the angular momentum operator algebra. The only inputs to this mathematical formalism are the basic

More information

Electronic properties of Graphene and 2-D materials

Electronic properties of Graphene and 2-D materials Electronic properties of Graphene and 2-D materials 2D materials background Carbon allotropes Graphene Structure and Band structure Electronic properties Electrons in a magnetic field Onsager relation

More information

Graphene, the two-dimensional allotrope of carbon,

Graphene, the two-dimensional allotrope of carbon, External Bias Dependent Direct To Indirect Band Gap Transition in Graphene Nanoribbon Kausik Majumdar,*, Kota V. R. M. Murali, Navakanta Bhat, and Yu-Ming Lin pubs.acs.org/nanolett Department of Electrical

More information