Presentation is loading. Please wait.

Presentation is loading. Please wait.

The physics is confusing

Similar presentations


Presentation on theme: "The physics is confusing"— Presentation transcript:

1 The physics is confusing

2 Time Indep SE EY = (-ħ22/2m + U)Y BCs : Ĥyn = Enyn (n = 1,2,3...)
Kinetic Potential Energy Energy BCs : Ĥyn = Enyn (n = 1,2,3...) En : eigenvalues (usually fixed by BCs) yn(x): eigenvectors/stationary states

3 Summary: Particle at a step
eikx + re-ikx teik’x eikx + re-ikx te-hx U0 x T 1 Classical Quantum E U0 $$$ Question: How do we make the curves approach each other?

4 Particle at a barrier U0 L x T 1 E U0 Classical Quantum Resonances
T Classical 1 Quantum E U0 Tunneling T ~ e-2kL, k ~ (U0-E) Resonances k’L = np, E = U0 + ħ2k’2/2m

5 Particle at a Barrier eikx + re-ikx Aeik’x + Be-ik’x teikx U0 x L
Boundary Conditions: y(0-) = y(0+) dy/dx|0- = dy/dx|0+ k = 2mE/ħ2 k’ = 2m(E-U0)/ħ2 y(L-) = y(L+) dy/dx|L- = dy/dx|L+ E > U0 k,k’ real

6 Particle at a Barrier eikx + re-ikx Aeik’x + Be-ik’x teikx U0 x L
1+ r = A + B k(1-r) = k’(A-B) 2 = (1+k’/k)A + (1-k’/k)B Aeik’L + Be-ik’L = teikL k’(Aeik’L – Be-ik’L) = kteikL 0 = (1-k’/k)Aeik’L + (1+k’/k)Be-ik’L

7 Particle at a Barrier eikx + re-ikx Aeik’x + Be-ik’x teikx U0 x L
A = 2e-ik’L(1+k’/k)/[(1+k’/k)2e-ik’L– (1-k’/k)2eik’L] B = 2eik’L(1-k’/k)[(1-k’/k)2eik’L-(1+k’/k)2e-ik’L] 2 = (1+k’/k)A + (1-k’/k)B 0 = (1-k’/k)Aeik’L + (1+k’/k)Be-ik’L

8 Particle at a Barrier eikx + re-ikx Aeik’x + Be-ik’x teikx U0 x L
A = 2e-ik’L(1+k’/k)/[(1+k’/k)2e-ik’L– (1-k’/k)2eik’L] B = 2eik’L(1-k’/k)[(1-k’/k)2eik’L-(1+k’/k)2e-ik’L] teikL = 2(2k’/k)/ [(1+k’/k)2e-ik’L– (1-k’/k)2eik’L] = 2kk’/[-i(k2+k’2)sink’L + 2kk’cosk’L]

9 Particle at a Barrier eikx + re-ikx Aeik’x + Be-ik’x teikx U0 x L
T = 4k2k’2/[(k2+k’2)2sin2k’L + 4k2k’2cos2k’L] Resonances: Maximum if cosk’L = 1, sink’L = 0 ie, k’L = 0, p, 2p, ...  L = 0, l/2, 3l/2, ....

10 More obvious if it’s a well
eikx + re-ikx Aeik’x + Be-ik’x teikx U0 L x ie, k’L = 0, p, 2p, ...  L = 0, l/2, 3l/2, .... Represent Resonances, with E > U0 (They would be bound states if E < U0) Here k = 2m(E-U0)/ħ2 k’ = 2mE/ħ2

11 Back to Barrier but lower Energy
k’ = ik eikx + re-ikx Ae-kx + Bekx teikx U0 L x T = 4k2k2/[(k2-k2)2sinh2kL + 4k2k2cosh2kL] Large or wide barriers: kL >> 1, sinhkL ~ coshkL ~ ekL/2 T ≈ 16 k2k2e-2kL/(k2+k2)2 ~ [16E(U0-E)/U02]e-2kL teikL = 2ikk/[(k2-k2)sinhkL + 2ikkcoshkL]

12 Back to Barrier but lower Energy
eikx + re-ikx Ae-kx + Bekx teikx U0 L x T ≈ [16E(U0-E)/U02]e-2kL U(x) Even though E < V0, T > 0 (tunneling) E x1 x2 More generally, WKB approximation T ~ exp[-2∫dx 2m[U(x)-E]/ħ2] x1 x2

13 Example: Tunneling T ~ exp[-2∫dx 2m[U(x)-E]/ħ2] Well Barrier
Alpha particle decay from nucleus Source-Drain tunneling in MOSFETs Single Electron Tunneling Devices (SETs) Resonant Tunneling Devices (RTDs)

14 Example: Tunneling Quantum states (Speer et al, Science ’06)
Needed for designing Heterojunctions/superlattices/ Photonic devices, etc Upswing in Current due To Tunneling Gloos

15 Barrier problem: Summary
x T Classical 1 Quantum E U0 Tunneling T ~ e-2kL, k ~ (U0-E) Resonances k’L = np, E = U0 + ħ2k’2/2m

16 Matlab plots As barrier width increases, we recover particle on a step

17 Matlab code subplot(2,2,4); % vary this from plot window to plot window m=9.1e-31;hbar=1.05e-34;q=1.6e-19; L=1e-9; %meter, vary this from plot window to plot window! U0=1; %electron Volts Ne=511;E=linspace(0,5,Ne); k=sqrt(2*m*E*q/hbar^2);%/m eta=sqrt(2*m*(E-U0)*q/hbar^2);%/m T=4.*k.^2.*eta.^2./((k.^2+eta.^2).^2.*sin(eta.*L).*sin(eta.*L) + 4.*k.^2.*eta.^2.*cos(eta.*L).*cos(eta.*L)); plot(E,T,'r','linewidth',3) title('L = 15 nm','fontsize',15) % vary this from plot window to plot window! grid on hold on tcl=2.*k./(k+eta);tcl=tcl.*conj(tcl); Tcl=real((eta./k).*tcl); plot(E,Tcl,'k--','linewidth',3) gtext('step','fontsize',15)

18 Can we solve for arbitrary Potentials?
Approximation Techniques Graphical solutions (e.g. particle in a finite box) Special functions (harmonic oscillator, tilted well, H-atom) Perturbation theory (Taylor expansion about known solution) Variational Principle (assume functional form of solution and fix parameters to get minimum energy) Numerical Techniques (next)

19 Finite Difference Method
y One particular mode yn-1 yn yn+1 xn-1 xn xn+1 yn-1 yn yn+1 y = Un-1yn-1 Unyn Un+1yn+1 Uy = Un-1 Un Un+1 = yn-1 yn yn+1 = [U][y]

20 What about kinetic energy?
yn-1 yn yn+1 xn-1 xn xn+1 yn-1 yn yn+1 y = (dy/dx)n = (yn+1/2 – yn-1/2)/a (d2y/dx2)n = (yn+1 + yn-1 -2yn)/a2

21 What about kinetic energy?
yn-1 yn yn+1 xn-1 xn xn+1 yn-1 yn yn+1 y = -ħ2/2m(d2y/dx2)n = t(2yn - yn+1 - yn-1) t = ħ2/2ma2

22 What about kinetic energy?
yn-1 yn yn+1 xn-1 xn xn+1 -ħ2/2m(d2y/dx2)n = t(2yn - yn+1 - yn-1) yn-1 yn yn+1 y = -t 2t -t yn-1 yn yn+1 Ty =

23 What about kinetic energy?
yn-1 yn yn+1 xn-1 xn xn+1 yn-1 yn yn+1 y = [H] = [T + U]

24 What next? y yn-1 yn yn+1 xn-1 xn xn+1
Now that we’ve got H matrix, we can calculate its eigenspectrum >> [V,D]=eig(H); % Find eigenspectrum >> [D,ind]=sort(real(diag(D))); % Replace eigenvalues D by sorting, with index ind >> V=V(:,ind); % Keep all rows (:) same, interchange columns acc. to sorting index (nth column of matrix V is the nth eigenvector yn plotted along the x axis)

25 Particle in a Box Results agree with analytical results E ~ n2
Finite wall heights, so waves seep out

26 Add a field

27 Or asymmetry Incorrect, since we need open BCs which we didn’t discuss

28 Harmonic Oscillator Shapes change from box: sin(px/L)  exp(-x2/2a2)
Need polynomial prefactor to incorporate nodes (Hermite) E~n2 for box, but box width increases as we go higher up  Energies equispaced E = (n+1/2)ħw, n = 0, 1, 2...

29 Add asymmetry

30 Matlab code t=1; Nx=101;x=linspace(-5,5,Nx);
%U=[100*ones(1,11) zeros(1,79) 100*ones(1,11)];% Particle in a box U=x.^2;U=U;%Oscillator %U=[100*ones(1,11) linspace(0,5,79) 100*ones(1,11)];%Tilted box %Write matrices T=2*t*eye(Nx)-t*diag(ones(1,Nx-1),1)-t*diag(ones(1,Nx-1),-1); %Kinetic Energy U=diag(U); %Potential Energy H=T+U; [V,D]=eig(H); [D,ind]=sort(real(diag(D))); V=V(:,ind); % Plot for k=1:5 plot(x,V(:,k)+10*D(k),'r','linewidth',3) hold on grid on end plot(x,U,'k','linewidth',3); % Zoom if needed axis([ ])

31 Grid issues For Small energies, finite diff. matches exact result
Deviation at large energy, where y varies rapidly Grid needs to be fine enough to sample variations

32 Summary Electron dynamics is inherently uncertain. Averages of observables can be computed by associating the electron with a probability wave whose amplitude satisfies the Schrodinger equation. Boundary conditions imposed on the waves create quantized modes at specific energies. This can cause electrons to exhibit transmission ‘resonances’ and also to tunnel through thin barriers. Only a few problems can be solved analytically. Numerically, however, many problems can be handled relatively easily.

33


Download ppt "The physics is confusing"

Similar presentations


Ads by Google