Vous êtes sur la page 1sur 4

John Beetar

Attosecond Optics
12/09/16
Final Project
HHG Spectrum of Single Atom Response (Hydrogen)

1. Code

%%HHG - Single Atom (Hydrogen)


del_t =0.861; %%Time Step (cutoff) 0.861
N = 4096; %%Number of points
t = -N*del_t/2 + del_t:del_t:N*del_t/2; %%Time Vector
t_ = 1:1:N-1;
T = 12; %%Pulse duration (fs)
T_au = T/(24.2e-3);
lambda = 1.6e-6; %%Carrier Wavelength
c = 299792458;
w_0 = ((2*pi*c)/lambda); %%Carrier frequency
w_au = w_0/(4.13e16);
I = 1e14; %% Intensity W/cm^2
I_au = I/(3.51e16);
ep = 8.85418782e-12;
E = sqrt((2e4)*I/(c*ep));
E_au2 = E/(5.1e11);
E_au = sqrt(I_au); %%Pulse Ampltude

m_e = 1; %%electron mass


h_bar = 1; %%reduced Planck constant
v = 0; %%integration constant
Ip = 13.6/(27.2);%%Ionization energy (eV/27.2) Hartree(Hydrogen)
a = 2*m_e*Ip; %%Hydrogen-Like parameter (au)
q = -1; %-1.602e-19; %%Electron Charge

%del_tp = 0.5*del_t; %%0.5


%del_ts = 0.5*del_t; %%0.5

%E_in = (E_au)*exp(-1.38*((t)/(T_au)).^2).*exp(1i*(w_au)*(t)); %%Input Pulse


%A = -1*(E_au)*(exp(-
((w_au)^2)/(4*2*log(2)/((T_au)^2))))*((1i*(pi)^(0.5))*(erfi(((w_au)/(2*sqrt(2
*log(2)/((T_au)^2))))-
1i*sqrt(2*log(2)/((T_au)^2)).*(t)))./(2*(sqrt(2*log(2)/((T_au)^2)))));

E_in2 = (E_au)*exp(-1.38*((t)/(T_au)).^2).*cos((w_au)*(t));
%A_2 = -(E_au/w_au)*exp(-1.38*((t)/(T_au)).^2).*sin((w_au)*(t));

m = N*del_t;

t2c = 1;
%Implementation

%Running through all recombination times


for t2 = ((-N*del_t/2) + (219)*del_t):del_t:(N*del_t/2) %((-
N*del_t/2) + del_t):del_t:(N*del_t/2) %((-N*del_t/2) +
((N/4)*del_t)):del_t:(N*del_t/2)

xn = 0;

%Considering all possible ionization times


for t1 = t2-((219)*del_t):del_t:t2-(1*del_t) %(-
N*del_t/2):del_t:t2-(1*del_t) %t2-((N/4)*del_t):del_t:t2-(1*del_t)

tau = t2-t1;

An = 0;
del_tp = (t2-t1)/200;
for n = t1:del_tp:t2
An = (-(E_au/w_au)*exp(-
1.38*((t1)/(T_au)).^2).*sin((w_au)*(t1)))+An;
end

Ps = q*((del_tp)/(tau))*An; %%Momentum

Sn = 0;
del_ts = (t2-t1)/400;
for si = t1:del_ts:t2
Sn = Sn + ((Ps - q*(-(E_au/w_au)*exp(-
1.38*((t1)/(T_au)).^2).*sin((w_au)*(t1))))/(2*m_e) - Ip);
end

Ph = exp((-1j)*(del_ts/h_bar)*Sn); %%Phase

Pd = Ps - q*(-(E_au/w_au)*exp(-
1.38*((t1)/(T_au)).^2).*sin((w_au)*(t1)));
d = ((1i)*(2^(7/2))*(a^(5/4))/(pi))*(Pd/(((Pd^2) + a)^3)); %%Matrix
element

Pdc = Ps - q*(-(E_au/w_au)*exp(-
1.38*((t2)/(T_au)).^2).*sin((w_au)*(t2)));
dc = conj((1i)*(2^(7/2))*(a^(5/4))/(pi))*(Pdc/(((Pdc^2) + a)^3));

QD = (pi/(v + ((1i)*(tau))/(2*m_e*h_bar)))^(1.5); %%Quantum


Diffusion
xn = xn + ((1i)/(del_t))*(QD)*(dc)*(Ph)*((E_au)*exp(-
1.38*((t2)/(T_au)).^2).*cos((w_au)*(t2)))*(d); %%Dipole term

end

x(t2c) = xn;
t2c = t2c+1;

end

x2 = x + conj(x); %%Final Dipole Term

X2 = (fft(x2));

Xf = (abs(X2)).^2; %%Power Spectrum

%Plotting Arrays for time and energy


t3 = ((-N*del_t/2) + (219)*del_t):del_t:(N*del_t/2); %((-N*del_t/2) +
del_t):del_t:(N*del_t/2); %((-N*del_t/2) + ((N/4)*del_t)):del_t:(N*del_t/2);
eVc = (6.626e-34)*(1/(1e-15*(del_t*(24.2e-3))))/(1.602e-19);
Energy = eVc/(length(Xf)):eVc/(length(Xf)):eVc;
t_f = del_t*(24.2e-3);
Femto = (-length(x2)/2)*t_f + t_f:t_f:(length(x2)/2)*t_f;

%Plots
figure('Name','High Harmonic Spectra of Hydrogen Atom')
subplot(1,2,1)
plot(Femto,x2)
title('Dipole Moment')
xlabel('Time [fs]')
ylabel('Amplitude [a.u.]')
axis([-20 20 -0.01 0.01])
subplot(1,2,2)
plot(Energy,log(Xf))
title('HHG Spectrum')
xlabel('Energy [eV]')
ylabel('log(Power) [a.u.]')
axis([0 40 -40 5])
2. Plots

Vous aimerez peut-être aussi