Lab Journal For EC258 Electromagnetic Waves Lab.: Piyush Kumar BTECH/60120/19 ECE
Lab Journal For EC258 Electromagnetic Waves Lab.: Piyush Kumar BTECH/60120/19 ECE
Lab Journal For EC258 Electromagnetic Waves Lab.: Piyush Kumar BTECH/60120/19 ECE
Piyush Kumar
BTECH/60120/19
ECE
Quiz answers
4. The Value Of E Within The Field Due To A Point Charge Can Be Found With The
Help Of
a) Coulomb's Laws
10. The resistivity of a material with resistance 200 ohm, length 10m and area twice that of
the length is
c) 400
11. To Plot the graph of Sin (100t) in MATLAB properly the best choice for tin code
a) t= 0:1:100
12. To plot the function x(t) = Sin(2Π100t)+Cos(2Π75t) appropriate choice for tin
code should be
c) t=linspace(0,1,150)
16.
Code
syms t x
Electric_Field = 50*sin(100000000*t-50*x)
Current_Density =10*sin(100000000*t-50*x)
Conductivity = Electric_Field/Current_Density
Result
Conductivity = 5
17.
Code
p=input('length in cm in x direction:a=');
q=input('length in cm in y direction:b=');
a=p/100
b=q/100
L = 2/(sqrt((1/a)^2 + (0/b)^2))
Result
Wavelength(L) = 0.04
19.
Code
b=0.1;
a=2.5*b;
A=1;
x=linspace(0,a,100);
y=linspace(0,b,100);
subplot(2,2,1);
m=1;
n=0;
[xx,yy]=meshgrid(x,y);
phix=cos(m*pi*xx/a);
phiy=cos(n*pi*yy/b);
zz = A*phix.*phiy;
mesh(xx,yy,zz);
title('TE10 Mode');
xlabel('x (metres)');
ylabel('y (metres)');
zlabel('z (metres)');
subplot(2,2,2);
m=2;
n=0;
[xx,yy]=meshgrid(x,y);
phix=cos(m*pi*xx/a);
phiy=cos(n*pi*yy/b);
zz = A*phix.*phiy;
mesh(xx,yy,zz);
title('TE20 Mode');
xlabel('x (metres)');
ylabel('y (metres)');
zlabel('z (metres)');
subplot(2,2,3);
m=0;
n=1;
[xx,yy]=meshgrid(x,y);
phix=cos(m*pi*xx/a);
phiy=cos(n*pi*yy/b);
zz = A*phix.*phiy;
mesh(xx,yy,zz);
title('TE01 Mode');
xlabel('x (metres)');
ylabel('y (metres)');
zlabel('z (metres)');
subplot(2,2,4);
m=1;
n=1;
[xx,yy]=meshgrid(x,y);
phix=cos(m*pi*xx/a);
phiy=cos(n*pi*yy/b);
zz = A*phix.*phiy;
mesh(xx,yy,zz);
title('TE11 Mode');
xlabel('x (metres)');
ylabel('y (metres)');
zlabel('z (metres)');
figure();
m=1;
n=0;
epsilon0=8.854e-12;
mu0=(4*3.14*10^(-7));
f=linspace(0.5e9,3e9,1000);
w=2*pi*f;
kc=(m*pi/a)^2+(n*pi/b)^2;
k=(w.^2)*mu0*epsilon0;
beta=sqrt(k-kc);
plot(f,beta);
title('Plot of beta vs Frequency');
xlabel('Frequency (Hz)');
ylabel('\beta');
Plot
20.
Code
w = 10^8;
c = 3*(10^8);
T = 2*pi/w
B = w/c
l = 2*pi/B
k = 2*pi/l
t1 = 0;
t2 = T/4;
t3 = T/2;
x = linspace(-2*l,2*l,1000)
E1 = 50*cos((w*t1)+(B.*x));
E2 = 50*cos((w*t2)+(B.*x));
E3 = 50*cos((w*t3)+(B.*x));
plot(x,E1,'--r',x,E2,'g',x,E3,'--b')
legend('t=0','t=T/4','t=T/2')
title(' Plot of E vs x')
xlabel(' x ')
ylabel(' E ')
Result
(i) k= 0.3333
lambda (wavelength) = 18.8496
T= 6.2832e-08
(ii) t=T/2
3.1416e-08
Plot
21.
Simulation No. 1
Using MATLAB, simulate and plot the phenomenon of Skin effect in current carrying
conductors as a function of the conductivity of the conductor and the frequency of operation.
AIM
2
δ=
(i)
√ ωμσ
For μ=μ 0=4 π × 10−7 H /m, σ copper =5.8 ×107 S/m
Plot Skin depth Vs Conductivity of material (Aluminum, Copper, Gold, and Silver)
Code
subplot(2,1,1)
u0=4*pi*(10^(-7))
c1=3.77*(10^7)
c2=4.11*(10^7)
c3=5.8*(10^7)
c4=6.3*(10^7)
f = linspace(0,2.*pi,500)
y1 = sqrt(2./(2*pi*f*u0*c1))
y2 = sqrt(2./(2*pi*f*u0*c2))
y3 = sqrt(2./(2*pi*f*u0*c3))
y4 = sqrt(2./(2*pi*f*u0*c4))
plot(f,y1,'r',f,y2,'g',f,y3,'b',f,y4,'k')
legend('Aluminium','Gold','Copper','Silver')
axis('equal')
xlabel('frequency (Hz)')
ylabel(' skin depth (um)')
title(' Plot of frequency vs skin depth for copper')
subplot(2,1,2)
u0=4*pi*(10^(-7))
f=10^9
c=linspace(3.*(10^7),7.*(10^7),100000)
y=sqrt(2./(2*pi*f*u0*c))
plot(c,y)
title('plot of skin depth vs conductivity')
xlabel(' conductivity (S/m)')
ylabel(' skin depth (um)')
Plot
Simulation No. 2
Using MATLAB, simulate and plot the variation of the time varying field as a function of
distance. Also plot the waveforms to depict linear, circular and elliptical polarization of the
wave.
AIM
Theory
Time varying Fields:
E ( z , t )= A sin( ωt−βz)
• When the electric field is at a maximum, the magnetic field is also at a maximum.
• The electric and magnetic fields are always perpendicular to one another.
• EM Radiation travels at the speed of light in a vacuum (3.00 x 108 m/s).
Plot z Versus E(z,0), E(z,T/4), and E(z, T/2) for z = 0, λ/4, λ/2, 3λ/4, λ, 5λ/4, 3λ/2, 7λ/4, 2λ.
Polarization:
Polarization is the term used to describe the way in which the electromagnetic wave
oscillates as it travels along.
Regarded as the locus of the tip of the electric field(in a plane perpendicular to the
direction of propagation) at a given point as a function of time.
For linear polarization, the tip of the electric field describes a straight line, for circular a
circle and for elliptical an ellipse.
Vertically polarized waves will oscillate up and down as it moves forward
Horizontally polarized waves will oscillate from side to side.
In circular polarization the wave oscillates in a circle as it moves along
Linear Polarization
E y ( z , t )= A sin( ωt−βz)
subplot(3,1,1)
w = 2*pi*6*(10^14)
B = 2*(10^6)
l = 0.0000005
t1 = 0
z = linspace(0,10*l,500)
E = 100*sin((w*t1)-(B*z))
plot(z,E)
title(' Plot of z vs E at t=0')
xlabel('axix z')
ylabel(' Electric field ')
subplot(3,1,2)
t2 = (1/(24*(10^14)))
E = 100*sin((w*t2)-(B*z))
plot(z,E)
title(' Plot of z vs E at t= T/4 ')
xlabel('axix z')
ylabel(' Electric field ')
subplot(3,1,3)
t3 = (1/(12*(10^14)))
E = 100*sin((w*t3)-(B*z))
plot(z,E)
title(' Plot of z vs E at t= T/2 ')
xlabel('axix z')
ylabel(' Electric field ')
Code for vertical and horizontal polarization
w = 2*pi*6*(10^14)
B = 2*(10^6)
l = 0.0000005
t1 = 0
x = linspace(0,10*l,500)
y = linspace(0,10*l,500)
z = linspace(0,10*l,500)
E = 100*sin((w*t1)-(B*z))
subplot(1,2,1)
plot3(E,y,z,'--b',x,E,z)
box on
title(' Vertically polarized ( E- polarized) ')
xlabel('x Electric field ')
ylabel(' y ')
zlabel(' z')
subplot(1,2,2)
plot3(x,E,z,'--b',E,y,z)
box on
title('Horizontally polarized (H- polarized)')
xlabel('x')
ylabel('y Electric field')
zlabel('z')
w = 2*pi*6*(10^14)
B = 2*(10^6)
l = 0.0000005
t1 = 0
x = linspace(0,10*l,500)
y = linspace(0,10*l,500)
z = linspace(0,20*l,1000)
Ey = 100*sin((w*t1)-(B*z))
Ex = 100*sin((w*t1)-(B*z)+(pi/2))
plot3(z,Ex,Ey)
box on
title(' Circular polarization ')
xlabel('x ')
ylabel(' y ')
zlabel(' z')
Plot
Simulation No. 3
A parallel-plate capacitor with plate area 5 cm2 and plate separation of 3 mm has a voltage 50 sin
103 t V applied to its plates. Using MATLAB, Compute the displacement current assuming (i) ε
= ϵ0 (ii) ε = 2ϵ0
AIM
Displacement Current
The displacement current is not a “real” current, in the sense that it does not
describe charges flowing through some region. However, it acts just like a real
current.
Whenever we have a changing Electric field, we can treat its effects as due to the
displacement current density arising from that field’s variations.
According to Ampere's law, the line integral of the magnetic field H around a
closed loop equals the total free current passing through the loop:∮ H . ds=I free .
Ampere's law can be expressed in differential form as ∇ × H=J free, where J is the
current density. The vector identity ∇ . ∇ × H=0 implies the steady-state limit of
the equation of continuity:∇ . J =0 .
Maxwell recognized that the more general form of the equation of continuity
∂ρ
∇ . J + =0 , where ρ is the charge density, requires a modification of Ampere's
∂t
law.
Substituting from the first of Maxwell's equations, ∇ . D=ρ , Ampere's law can be
∂D
generalized to∇ × H=J + , which becomes the third of Maxwell's equations.
∂t
The added term is known as the displacement current since it involves the rate of
change of the dielectric displacement D.
This provides a mechanism whereby a time-varying electric field can create a
magnetic field, complementary to Faraday's law, in which a time-varying
magnetic field can produce an electric field.
What Maxwell called the "mutual embrace" of electric and magnetic fields can
produce propagating electromagnetic waves. This would not be possible without
the displacement current.
Thus the Maxwell’s equation for a time varying field is modified as
∇ × H=J c + J d
The conduction current density J c and the displacement current density J Dare
given as
J c =σE
dQ dD dE εS dV
I c= =S =εS = =I D
dt dt dt d dt
∂ D ε dV
J D= =
∂ t d dt
Hence,
εS dV dV
I D =J D . S= =C
d dt dt
Given, S = 5cm2, d = 3 mm, V = 50 sin 103 t V.
Plot Versus for
ε =ε 0 , 1.5 ε 0 , 2 ε 0 ,2.5 ε 0 , 3 ε 0
Code
s = 0.0005
d = 0.003
t = linspace(0,0.03,1000)
V = 50000*cos(1000*t)
hold on
for r = 1:1:2
E = 8.854*10^(-12)*r
I = (E*s/d)*V
plot(t,I)
end
xlabel("Time")
ylabel("Displacement current")
title("Id vs E")
Plot
Simulation No. 4
An electric field in free space is given by E = 50 cos (108t + β x) ay V/m. Using MATLAB,
Compute (i) k, λ and T (ii) the time it takes to travel a distance of λ/2. (iii) Plot the wave at t = 0,
T/4, and T/2.
AIM
EM Wave
The direction of propagation of wave is -ax which can be inferred from the positive
sign in (ωt+βx).
Compute k, λ and T.
β = ω/c, λ = 2π/β, In free space, β =k = 2π/λ,
T is the period of the wave = λ, i.e., it takes T seconds to travel a distance λ at speed
c.
The time it takes to travel a distance of λ/2, t1 is given as
t1 =λ/2c
Plot the wave at t = 0, T/4, and T/2, hence confirm the direction of wave.
Code
w = 10^8;
c = 3*(10^8);
T = 2*pi/w
B = w/c
l = 2*pi/B
k = 2*pi/l
t1 = 0;
t2 = T/4;
t3 = T/2;
x = linspace(-2*l,2*l,1000)
E1 = 50*cos((w*t1)+(B.*x));
E2 = 50*cos((w*t2)+(B.*x));
E3 = 50*cos((w*t3)+(B.*x));
plot(x,E1,'--r',x,E2,'g',x,E3,'--b')
legend('t=0','t=T/4','t=T/2')
title(' Plot of E vs x')
xlabel(' x ')
ylabel(' E ')
Result
(i) k= 0.3333
lambda (wavelength) = 18.8496
T= 6.2832e-08
(ii) t=T/2
3.1416e-08
Plot
Simulation No. 5
AIM
Examine the characteristics of the EM wave in free space and in a specified medium.
Code
syms t x y z
c = 3*10^8
B = 50
w = 50*c
e0 = 8.85*10^(-12)
u0 = 4*pi*10^(-7)
E = 20*(cos(w*t-50*x))
Ediff = diff(E,t)
J = (e0)*Ediff
E1 = [0,E,0]
X = [x,y,z]
H = int(curl(E1,X),t)*(-1/u0)
x1 = linspace(0,1,1000)
t1 = linspace(0,50,1000)
E2 = 20*(cos(w*t1-50*x1))
subplot(2,1,1)
plot(x1,E2)
title(' Plot of E vs x ( In free space)')
xlabel(' x (m)')
ylabel('E (V/m)')
subplot(2,1,2)
H1 = 0.053*cos(w*t1-50*x1)
plot(x1,H1)
title(' Plot of H vs y ( In free space)')
xlabel(' y (m)')
ylabel(' H (A/m)')
syms t x y z
c = 3*10^8
w = 10^8
e0 = 8.85*10^(-12)
u0 = 4*pi*10^(-7)
u = u0
e = 4*e0
B = w*sqrt(u*e)
T = 2*pi/w;
l = 2*pi/B;
E = 20*(sin(w*t-B*z))
Ediff = diff(E,t)
J = (e)*Ediff
E1 = [0,0,E]
X = [x,y,z]
H = int(curl(E1,X),t)*(-1/u)
z = linspace(0,1,500)
t1 = linspace(0,50,500)
E2 = 20*(sin(w*t1-B*z))
subplot(2,1,1)
plot(z,E2)
title(' Plot of E vs z ( In specified medium)')
xlabel(' x (m)')
ylabel('E (V/m)')
subplot(2,1,2)
H1 = -0.106*sin(w*t1-B*z)
plot(z,H1)
title(' Plot of H vs y ( In specified medium)')
xlabel(' y (m)')
ylabel(' H (A/m)')
Plot
Simulation No. 6
A plane wave propagating through a medium with ϵr = 8, µr = 2 and E = 0.5 e-z/3 sin(108t – βz) ax
V/m. Using MATLAB, compute (i) β (ii) the loss tangent (iii) Intrinsic impedance (iv) Wave
velocity (v) H field.
AIM
Examine the characteristics of the EM wave in the specified dielectric medium. Plot the E and H
field in the above media.
Theory
σ μ
Attenuation constant, α ≈
2 √ ε
dB/m
σ2
Phase shift constant, β ≈ ω √ με 1+ ( 8 ω2 ε2 ) rad/m
ω 1 σ2
Velocity of the wave, ν= ≈
β √ με
1− 2 2
8ω ε ( ) m/s
μ σ
Intrinsic impedance, η ≈
η=E/ H
√ ε (
1+ j
2 ωε
Ω )
Code
syms z t
u = 2*4*pi*10^(-7);
e = 8*8.854*10^(-12);
w = 10^8;
alpha = 1/3;
sig = 2*alpha*sqrt(e/u);
beta = (w*sqrt(u*e))*(1 + (sig^2)/(8*w^2*e^2))
vel = w/beta
loss_tangent = tan(sig/(w*e))
real_part = sqrt(u/e);
img_part = sqrt(u/e)*(sig/(2*w*e));
impedance = complex(real_part,img_part)
t = linspace(0,0.0000005,10000);
z = linspace(0,5*10^-7,10000);
p = zeros(1,10000);
E = 0.5.*exp(-z/3).*sin(w*t-beta*z);
H = E/impedance;
plot3(z,E,p,'--b',z,p,H)
legend('Electric field','Magnetic field')
xlabel('x')
ylabel('Electric field')
zlabel('Magnetic field')
Result
beta = 1.3759
vel = 7.2681e+07
loss tangent = 0.5459
impedance = 1.8837e+02 + 4.7060e+01i
Plot
Simulation No. 7
In free space (z ≤ 0), a plane wave with Hi = 10 cos (108t - βz) ax mA/m is incident normally on a
lossless medium (µ = 8µ0, ε = 2ϵ0) in region z ≥ 0. Using MATLAB, compute and plot the
reflected wave Hr, Er and the transmitted wave Ht and Et.
AIM
Study the reflected and transmitted phenomena of Plane wave at normal incidence on a lossless
dielectric medium.
Theory
Reflection of Plane wave at normal incidence
ω
Phase shift constant, β=
c
Intrinsic impedance, η=√ (μ0 /ε 0 ) = 120 π Ω
η=E/ H
Ero η2−η1
=Γ =
Eio η2 +η1
E¿
=τ=1+ Γ
Eio
subplot(2,1,2)
plot(z0,Hi,'r');
hold on
plot(z0,Hr,'b');
hold on
plot(z1,Ht,'g');
legend('Hi','Hr','Ht')
Result
beta0 = 0.3333
beta1 = 1.3342
eta0 = 376.7343
eta1 = 753.4686
Hi = 10*cos(100000000*t - z0/3)
Ei = (517779691909861*cos(100000000*t - z0/3))/137438953472
Er = -(517779691909861*cos(100000000*t + z0/3))/412316860416
Et = (517779691909861*cos(100000000*t (6008892807144943*z1) / 4503599627370496)) /
103079215104
Hr = -(66275800564462208*cos(100000000*t + z0/3))/19882740169338663
Ht = (132551601128924416*cos(100000000*t - (6008892807144943*z1) /
4503599627370496)) /19882740169338663
Plot
Simulation No. 8
Given a uniform plane wave in air as Ei = 40 cos(ωt –βz)ax + 30 sin(ωt –βz)ay V/m. Using
MATLAB compute and plot
(i) Hi
(ii) If the wave encounters a perfectly conducting plate normal to the z-axis at z = 0,
find the reflected wave Er and Hr.
(iii) The total E and H fields for z ≤ 0.
(iv) The time-average Poynting vectors for z ≤ 0 and z ≥ 0.
AIM
Study the reflected and transmitted phenomena of Plane wave at normal incidence on a perfectly
conducting medium.
E and H are related through intrinsic impedance and incident and reflected fields are related
through reflection/transmission coefficient.
(i) Hi = Ei / η0
Er = Γ Ei = -Ei
(iv) For z ≤ 0,
2
| E1 s|
℘1 av = ak
2 η1
For z ≥ 0, ℘2 av =
| E2 s|
ak = 0
2 η2
THEORY
When a plane wave from one medium meets a different medium, it is partly reflected and partly
transmitted. The proportion of the incident wave that is reflected or transmitted depends on the
constitutive parameters (e, ju, a) of the two media involved. Here we will assume that the
incident wave plane is normal to the boundary between the media; oblique incidence of plane
waves will be covered in the next section after we understand the simpler case of normal
incidence. Suppose that a plane wave propagating along the +z-direction is incident normally on
the boundary z = 0 between medium 1 (z < 0) characterized by er,, eu fix and medium 2 (z > 0)
characterized by a2, e2, /*2> as shown in Figure 10.11. In the figure, subscripts /, r, and t denote
incident, reflected, and transmitted waves, respectively. The incident, reflected, and transmitted
waves shown in Figure 10.11 are obtained as follows:
Incident Wave: (E,, H,) is traveling along +az in medium 1. If we suppress the time factor eJo"
and assume that
Eis(z) = Eio*e-y'z ax
then
Ers(z) = Eroey1z ax
then
Hrs(z)= Hroey1z(-ay) = -Ero /η1ey1z(ay)
where Ers has been assumed to be along ax; we will consistently assume that for normal incident
Ei, Er, and Et, have the same polarization.
Transmitted Wave:
(E,, Ht) is traveling along +az in medium 2. If
Ets(z) = Etoe-y2z ax
then
Hts(z)= Htoe-y2zay = -Eto /η2ey1z(ay)
E1 = Ei + Er, H1 = Hi + Hr
E2 = Et, H2 = Ht
We now define the reflection coefficient ɽ and the transmission coefficient T
ɽ = (η2 – η1)/ (η2+ η1)
T = (2*η2)/ ( η2+ η1)
Notice that 1+ ɽ = T
CODE
syms t z
w = 10^8 ;
c = 3*(10^8);
b = w/c ;
u0 = 4*pi*(10^(-7));
E0 = 8.854*(10^(-12));
eta1 = sqrt(u0/E0);
eta2 = 0 ;
rc = (eta2 - eta1)/(eta1 + eta2);
tc = (2*eta2)/(eta1 + eta2);
Eix = 40*cos((w*t)-b*z)
Eiy = 30*sin((w*t)-b*z)
Hiy = -40*cos((w*t)-b*z)/eta1
Hix = 30*sin((w*t)-b*z)/eta1
Erx = -40*cos(w*t+b*z)
Ery = -30*sin(w*t+b*z)
Hry = Erx/eta1
Hrx = -Ery/eta1
Etx = Eix + Erx
Ety = Eiy + Ery
Htx = Hix + Hrx
Hty = Hiy + Hry
Poynting = ((Etx)^2 + (Ety)^2)/(2*eta1)
t = linspace(0,0.0000003,1000);
z = linspace(0,0.0000003,1000);
Eix = 40*cos((w*t)-b*z);
Eiy = 30*sin((w*t)-b*z);
Hiy = -40*cos((w*t)-b*z)/eta1 ;
Hix = 30*sin((w*t)-b*z)/eta1 ;
subplot(3,2,1)
plot3(Hix,Hiy,z)
xlabel('Hix')
ylabel('Hiy')
zlabel('z')
Erx = -40*cos(w*t+b*z);
Ery = -30*sin(w*t+b*z);
Hry = Erx/eta1;
Hrx = -Ery/eta1;
subplot(3,2,2)
plot3(Erx,Ery,z)
xlabel('Erx')
ylabel('Ery')
zlabel('z')
subplot(3,2,3)
plot3(Hrx,Hry,z)
xlabel('Hrx')
ylabel('Hry')
zlabel('z')
subplot(3,2,4)
plot3(Eix+Erx,Ery+Eiy,z)
xlabel('E total x')
ylabel('E total y')
zlabel('z')
subplot(3,2,5)
plot3(Hix+Hrx,Hry+Hiy,z)
xlabel('H total x')
ylabel('H total y')
zlabel('z')
RESULT
(i) Hix = 0.0796317172840721*sin(100000000*t - z/3)
CONCLUSION
Since for the region z>=0, medium is perfectly conducting hence Electric and Magnetic field will
not exist in that region. They will exist in region one that is z<0
Simulation No. 9
Using MATLAB, obtain the following for each of the loads given above.
• The Standing Wave pattern
• Calculate SWR for each load. And plot the normalized SWR pattern.
AIM
THEORY
Use eqns.
Z L + j Z 0 tanhβl
1) Z¿ =Z 0 [ Z 0+ j Z L tanhβl ]
Z¿ =input impedance
Z 0=charateristic impedance
ZL=load impedance
βl=electric length of line .
Z L−Z 0 ¿
2 ¿ Γ ¿L = & S = 1+¿ Γ L∨ 1−¿ Γ ∨¿ ¿ ¿
Z L+ Z 0 L
RL
= VS(0) = V SO (1+ Γ L)
+¿¿
3) VSO =VSg
R L + Rg
V Sg RL
+¿=
V SO
[ ]
(1+ Γ L ) R L+ 50
¿
amplitude¿
VSO = input voltage ; V +¿=wave
SO .
5)Vmax = Vso+(1 + Γ L)
Vmin = Vso+(1 - Γ L)
c=3*10^8;
f=600*10^6;
lambda=c/f;
l=0.75*lambda;
b=(2*pi)/lambda;
vg=10;
zg=50;
zo=50;
zl=0;
zin=zo*((zl+(zo*tanh(b*l)*j))/(zo+(zl*tanh(b*l))));
r=(zl-zo)/(zl+zo)
s=(1+abs(r))/(1-abs(r))
vso=(vg*zin)/((zin+zg)*(1+abs(r)));
vmax=vso*(1+abs(r))
vmin=vso*(1-abs(r))
z=linspace(-1,1,1000);
vf=vso*exp((-b*z)*j);
vb=vso*r*exp((b*z)*j);
v=vf+vb;
subplot(2,1,1);
plot(z,v,'y')
hold ON;
vn=abs(v)/abs(vs);
subplot(2,1,2);
plot(z,vn,'m')
xlabel('lambda(m)');
ylabel ('|V(z)|/|Vo+|');
grid On;
c=3*10^8;
f=600*10^6;
lambda=c/f;
l=0.75*lambda;
b=(2*pi)/lambda;
vg=10;
zg=50;
zo=50;
zl1=100;
zin1=zo*((zl1+(zo*tanh(b*l)*j))/(zo+(zl1*tanh(b*l))));
r1=(zl1-zo)/(zl1+zo)
s1=(1+abs(r1))/(1-abs(r1))
vs1=(vg*zin1)/((zin1+zg)*(1+abs(r1)));
vmax1=vs1*(1+abs(r1))
vmin1=vs1*(1-abs(r1))
z=linspace(-1,1,1000);
vf1=vs1*exp((-b*z)*j);
vb1=vs1*r1*exp((b*z)*j);
v1=vf1+vb1;
subplot(2,1,1);
plot(z,v1,'y')
hold ON;
vn1=abs(v1)/abs(vs1);
subplot(2,1,2);
plot(z,vn1,'m')
xlabel('lambda(m)');
ylabel ('|V(z)|/|Vo+|');
grid On;
c=3*10^8;
f=600*10^6;
lambda=c/f;
l=0.75*lambda;
b=(2*pi)/lambda;
vg=10;
zg=50;
zo=50;
zl3=25-25*j;
zin3=zo*((zl3+(zo*tanh(b*l)*j))/(zo+(zl3*tanh(b*l))));
r3=(zl3-zo)/(zl3+zo)
s3=(1+abs(r3))/(1-abs(r3))
vs3=(vg*zin3)/((zin3+zg)*(1+abs(r3)));
vmax3=vs3*(1+abs(r3))
vmin3=vs3*(1-abs(r3))
z=linspace(-1,1,1000);
vf3=vs3*exp((-b*z)*j);
vb3=vs3*r3*exp((b*z)*j);
v3=vf3+vb3;
subplot(2,1,1);
plot(z,v3,'y')
hold On;
vn3=abs(v3)/abs(vs3);
subplot(2,1,2);
plot(z,vn3,'m')
xlabel('lambda(m)');
ylabel ('|V(z)|/|Vo+|');
grid On;
A right-hand circularly polarized wave at 1.5 GHz is propagating through a material with er = 6.2
and mr = 2.0 and arrives at an interface with air. It is incident at an elevation angle of 15° and an
azimuthal angle of 45°. The wave has an amplitude of 12 V/m. The interface lies in the x-y
plane. Using MATLAB, Compute
(i) the angle of incidence q1.
(ii) the critical angle and the Brewster’s angles for this configuration for both
polarizations.
(iii) the reflection and transmission coefficients for both polarizations.
AIM
To visualize the phenomenon of reflection, and total transmission under oblique incidence
condition.
where n1 and n2 are the refractive indices of the two media. The refractive
indices may be written as
Code:
c=3*10^8;
eo=8.85*10^(-12);
uo=1.26*10^(-6);
er1=6.2;
ur1=2;
e1=er1*eo;
u1=ur1*uo;
e2=eo;
u2=uo;
n1=c*sqrt(e1*u1);
n2=c*sqrt(e2*u2);
ita1=sqrt(u1/e1);
ita2=sqrt(u2/e2);
disp("incident angle is")
thi=15
disp("transmitted angle is")
tht=rad2deg(asin(n1*sin((deg2rad(thi))/n2)))
disp("Critical angle for both polarization:")
thc=rad2deg(asin((n2/n1)))
thb1=rad2deg(asin(sqrt((1-((u1*e2)/(u2*e1)))/(1-(u1.^2/u2.^2)))));
if(thb1>0)
disp("Brewster angle for TE is")
thb1
else
disp("Brewster angle for TE does not exist")
end
thb2=rad2deg(asin(sqrt((1-((u2*e1)/(u1*e2)))/(1-(e1.^2/e2.^2)))));
if(thb2>0)
disp("Brewster angle for TM is")
thb2
else
disp("Brewster angle for TM does not exist")
end
disp("Reflection coefficient of TE is")
r1=(ita2*cos(deg2rad(thi))-ita1*cos(deg2rad(tht)))/(ita2*cos(deg2rad(thi))
+ita1*cos(deg2rad(tht))
disp("Reflection coefficient of TM is")
r2=(ita2*cos(deg2rad(tht))-ita1*cos(deg2rad(thi)))/(ita2*cos(deg2rad(tht))
+ita1*cos(deg2rad(thi))
disp("Transmission coeffiecient of TE is")
tau1=1+r1
disp("Transmission coeffiecient of TM is")
tau2=(cos(deg2rad(thi))/cos(deg2rad(tht)))*(1+r2)
R1=(abs(r1)).^2;
R2=(abs(r2)).^2;
T1=((abs(tau1)).^2)*(ita1/ita2)*(cos(deg2rad(tht))/cos(deg2rad(thi)));
T2=((abs(tau2)).^2)*(ita1/ita2)*(cos(deg2rad(tht))/cos(deg2rad(thi)));
disp("Percentage reflectance for TE")
PR1=R1*100
disp("Percentage transmittance for TE")
PT1=T1*100
if(round(PR1+PT1,1)==100)
disp("energy is conserved for TE")
else
disp("energy is not conserved for TE")
end
disp("Percentage reflectance for TM")
PR2=R2*100
disp("Percentage transmittance for TM")
PT2=T2*100
if (round(PR2+PT2,1)==100)
disp("energy is conserved for TM")
else
disp("energy is not conserved for TM")
end
Result:
incident angle is : thi = 15
transmitted angle is : tht =65.7042
Critical angle for both polarization: thc = 16.4979
Brewster angle for TE does not exist.
Brewster angle for TM is : thb2 = 13.6997
Reflection coefficient of TE is : r1 = 0.6104
Reflection coefficient of TM is: r2 = - 0.1429
Transmission coeffiecient of TE is : tau1 =1.6104
Transmission coeffiecient of TM is : tau2 = 2.0122
Discussion:
For perpendicular polarization (TE), electric field is perpendicular to the plane of incidence For
parallel polarization (TM), electric field is parallel to the plane of incidence.
At Brewster angle of incidence of the EM wave from region I, there will be no reflection from
region II, all the EM waves will be absorbed.
Light strikes an angle of incidence greater than critical angle, all of the light energy
Simulation No. 11
Use MATLAB to visualize the first four electromagnetic modes in a rectangular waveguide with
a/b = 2.25 and plot the phase constant b of the fundamental mode from 0.5 GHz up to 3.0 GHz.
AIM
1 mπ 2 nπ 2
Use eqn. fc =
mn
2 π √ μϵ √( a)( )
+
b
Hz
mπ 2 nπ 2
mn
√
β g = ω2 μϵ − ( ) ( ) rad/m
a
−
b
Theory
A transverse mode of electromagnetic radiation is a particular electromagnetic field pattern of the
radiation in the plane perpendicular (i.e., transverse) to the radiation's propagation direction. Transverse
modes occur in radio waves and microwaves confined to a waveguide, and also in light waves in an
optical fiber and in a laser's optical resonator.
In transverse electric mode there is no electric field in the direction of propagation. These are sometimes
called H modes because there is only a magnetic field along the direction of propagation (H is the
conventional symbol for magnetic field).
In transverse magnetic mode there is no magnetic field in the direction of propagation. These are
sometimes called E modes because there is only an electric field along the direction of propagation.
The cutoff frequency is the operating frequency below which attenuation occurs and above which
propagation takes place.
Code
b=0.1;
a=2.25*b;
A=1;
x=linspace(0,a,100);
y=linspace(0,b,100);
subplot(2,2,1);
m=1;
n=0;
[xx,yy]=meshgrid(x,y);
phix=cos(m*pi*xx/a);
phiy=cos(n*pi*yy/b);
zz = A*phix.*phiy;
mesh(xx,yy,zz);
title('TE10 Mode');
xlabel('x (metres)');
ylabel('y (metres)');
zlabel('z (metres)');
subplot(2,2,2);
m=2;
n=0;
[xx,yy]=meshgrid(x,y);
phix=cos(m*pi*xx/a);
phiy=cos(n*pi*yy/b);
zz = A*phix.*phiy;
mesh(xx,yy,zz);
title('TE20 Mode');
xlabel('x (metres)');
ylabel('y (metres)');
zlabel('z (metres)');
subplot(2,2,3);
m=0;
n=1;
[xx,yy]=meshgrid(x,y);
phix=cos(m*pi*xx/a);
phiy=cos(n*pi*yy/b);
zz = A*phix.*phiy;
mesh(xx,yy,zz);
title('TE01 Mode');
xlabel('x (metres)');
ylabel('y (metres)');
zlabel('z (metres)');
subplot(2,2,4);
m=1;
n=1;
[xx,yy]=meshgrid(x,y);
phix=cos(m*pi*xx/a);
phiy=cos(n*pi*yy/b);
zz = A*phix.*phiy;
mesh(xx,yy,zz);
title('TE11 Mode');
xlabel('x (metres)');
ylabel('y (metres)');
zlabel('z (metres)');
figure();
m=1;
n=0;
epsilon0=8.854e-12;
mu0=(4*3.14*10^(-7));
f=linspace(0.5e9,3e9,1000);
w=2*pi*f;
kc=(m*pi/a)^2+(n*pi/b)^2;
k=(w.^2)*mu0*epsilon0;
beta=sqrt(k-kc);
plot(f,beta);
title('Plot of beta vs Frequency');
xlabel('Frequency (Hz)');
ylabel('\beta');
Plot
Discussion
Beta remains zero until some cutoff frequency and then increases with increase in frequency.
Plot is obtained for Transverse electric mode.
Simulation No. 12
Write a MATLAB program that determines the first 20 modes supported by an air-filled
rectangular waveguide and sorts them to be in ascending order, starting with the fundamental
mode. The program should output a formatted table that labels each mode as either TEmn or
TMmn along with its cutoff frequency. Create five difference tables, one for each of the
following five cases: Table 1: a = 0.5 cm and b = 1.0 cm Table 2: a = 1.0 cm and b = 1.0 cm
Table 3: a = 1.5 cm and b = 1.0 cm Table 4: a = 2.0 cm and b = 1.0 cm Table 5: a = 2.5 cm and b
= 1.0 cm.
AIM
1 mπ 2 nπ 2
Use eqn. fc =
mn
2 π √ μϵ √( a)( )
+
b
Hz
mπ 2 nπ 2
mn
√
β g = ω2 μϵ − ( ) ( ) rad/m
a
−
b
THEORY
A transverse mode of electromagnetic radiation is a particular electromagnetic field pattern of the
radiation in the plane perpendicular (i.e., transverse) to the radiation's propagation direction. Transverse
modes occur in radio waves and microwaves confined to a waveguide, and also in light waves in an
optical fiber and in a laser's optical resonator.
In transverse electric mode there is no electric field in the direction of propagation. These are sometimes
called H modes because there is only a magnetic field along the direction of propagation (H is the
conventional symbol for magnetic field).
In transverse magnetic mode there is no magnetic field in the direction of propagation. These are
sometimes called E modes because there is only an electric field along the direction of propagation.
The cutoff frequency is the operating frequency below which attenuation occurs and above which
propagation takes place.
CODE
a=0.5e-2;
b=1e-2;
er=1;
mur=1;
e0=8.854e-12;
mu0=(4*3.14*10^(-7));
index=1;
for m=1:10
for n=1:10
mds(index,1)=1;
mds(index,2)=m;
mds(index,3)=n;
mds(index,4)=3e8/sqrt(er*mur)*sqrt((m*pi/a)^2+(n*pi/b)^2);
index=index+1;
end
end
for m=0:9
for n=0:9
if m || n
mds(index,1)=2;
mds(index,2)=m;
mds(index,3)=n;
mds(index,4)=3e8/sqrt(er*mur)*sqrt((m*pi/a)^2+ (n*pi/b)^2);
index=index+1;
end
end
end
mode_string='ME';
mds=sortrows(mds,4);
mode_row = strings(1,20)';
freq_row = zeros(1,20)';
for k = 1:20
mode_row(k) = append("T" , mode_string(mds(k, 1)) , string(mds(k, 2)) , string(mds(k, 3)));
freq_row(k) = mds(k, 4)/(2*pi*1e9);
end
var_names = {'mode', 'Cutoff Frequency (GHz)'};
Table_1 = table(mode_row, freq_row, 'VariableNames', var_names)
a=1e-2;
b=1e-2;
er=1;
mur=1;
e0=8.854e-12;
mu0=(4*3.14*10^(-7));
index=1;
for m=1:10
for n=1:10
mds(index,1)=1;
mds(index,2)=m;
mds(index,3)=n;
mds(index,4)=3e8/sqrt(er*mur)*sqrt((m*pi/a)^2+(n*pi/b)^2);
index=index+1;
end
end
for m=0:9
for n=0:9
if m || n
mds(index,1)=2;
mds(index,2)=m;
mds(index,3)=n;
mds(index,4)=3e8/sqrt(er*mur)*sqrt((m*pi/a)^2+ (n*pi/b)^2);
index=index+1;
end
end
end
mode_string='ME';
mds=sortrows(mds,4);
mode_row = strings(1,20)';
freq_row = zeros(1,20)';
for k = 1:20
mode_row(k) = append("T" , mode_string(mds(k, 1)) , string(mds(k, 2)) , string(mds(k, 3)));
freq_row(k) = mds(k, 4)/(2*pi*1e9);
end
var_names = {'mode', 'Cutoff Frequency (GHz)'};
Table_2 = table(mode_row, freq_row, 'VariableNames', var_names)
a=1.5e-2;
b=1e-2;
er=1;
mur=1;
e0=8.854e-12;
mu0=(4*3.14*10^(-7));
index=1;
for m=1:10
for n=1:10
mds(index,1)=1;
mds(index,2)=m;
mds(index,3)=n;
mds(index,4)=3e8/sqrt(er*mur)*sqrt((m*pi/a)^2+(n*pi/b)^2);
index=index+1;
end
end
for m=0:9
for n=0:9
if m || n
mds(index,1)=2;
mds(index,2)=m;
mds(index,3)=n;
mds(index,4)=3e8/sqrt(er*mur)*sqrt((m*pi/a)^2+ (n*pi/b)^2);
index=index+1;
end
end
end
mode_string='ME';
mds=sortrows(mds,4);
mode_row = strings(1,20)';
freq_row = zeros(1,20)';
for k = 1:20
mode_row(k) = append("T" , mode_string(mds(k, 1)) , string(mds(k, 2)) , string(mds(k, 3)));
freq_row(k) = mds(k, 4)/(2*pi*1e9);
end
var_names = {'mode', 'Cutoff Frequency (GHz)'};
Table_3 = table(mode_row, freq_row, 'VariableNames', var_names)
a=2e-2;
b=1e-2;
er=1;
mur=1;
e0=8.854e-12;
mu0=(4*3.14*10^(-7));
index=1;
for m=1:10
for n=1:10
mds(index,1)=1;
mds(index,2)=m;
mds(index,3)=n;
mds(index,4)=3e8/sqrt(er*mur)*sqrt((m*pi/a)^2+(n*pi/b)^2);
index=index+1;
end
end
for m=0:9
for n=0:9
if m || n
mds(index,1)=2;
mds(index,2)=m;
mds(index,3)=n;
mds(index,4)=3e8/sqrt(er*mur)*sqrt((m*pi/a)^2+ (n*pi/b)^2);
index=index+1;
end
end
end
mode_string='ME';
mds=sortrows(mds,4);
mode_row = strings(1,20)';
freq_row = zeros(1,20)';
for k = 1:20
mode_row(k) = append("T" , mode_string(mds(k, 1)) , string(mds(k, 2)) , string(mds(k, 3)));
freq_row(k) = mds(k, 4)/(2*pi*1e9);
end
a=2.5e-2;
b=1e-2;
er=1;
mur=1;
e0=8.854e-12;
mu0=(4*3.14*10^(-7));
index=1;
for m=1:10
for n=1:10
mds(index,1)=1;
mds(index,2)=m;
mds(index,3)=n;
mds(index,4)=3e8/sqrt(er*mur)*sqrt((m*pi/a)^2+(n*pi/b)^2);
index=index+1;
end
end
for m=0:9
for n=0:9
if m || n
mds(index,1)=2;
mds(index,2)=m;
mds(index,3)=n;
mds(index,4)=3e8/sqrt(er*mur)*sqrt((m*pi/a)^2+ (n*pi/b)^2);
index=index+1;
end
end
end
mode_string='ME';
mds=sortrows(mds,4);
mode_row = strings(1,20)';
freq_row = zeros(1,20)';
for k = 1:20
mode_row(k) = append("T" , mode_string(mds(k, 1)) , string(mds(k, 2)) , string(mds(k, 3)));
freq_row(k) = mds(k, 4)/(2*pi*1e9);
end
var_names = {'mode', 'Cutoff Frequency (GHz)'};
Table_5 = table(mode_row, freq_row, 'VariableNames', var_names)
OUTPUT
Table_1 =
20×2 table
"TE01" 15
"TE02" 30
"TE10" 30
"TM11" 33.5410196624968
"TE11" 33.5410196624968
"TM12" 42.4264068711929
"TE12" 42.4264068711929
"TE03" 45
"TM13" 54.0832691319598
"TE13" 54.0832691319598
"TE04" 60
"TE20" 60
"TM21" 61.8465843842649
"TE21" 61.8465843842649
"TM14" 67.0820393249937
"TM22" 67.0820393249937
"TE14" 67.0820393249937
"TE22" 67.0820393249937
"TE05" 75
"TM23" 75
Table_2 =
20×2 table
"TE01" 15
"TE10" 15
"TM11" 21.2132034355964
"TE11" 21.2132034355964
"TE02" 30
"TE20" 30
"TM12" 33.5410196624968
"TM21" 33.5410196624968
"TE12" 33.5410196624968
"TE21" 33.5410196624968
"TM22" 42.4264068711929
"TE22" 42.4264068711929
"TE03" 45
"TE30" 45
"TM13" 47.4341649025257
"TM31" 47.4341649025257
"TE13" 47.4341649025257
"TE31" 47.4341649025257
"TM23" 54.0832691319598
"TM32" 54.0832691319598
Table_3 =
20×2 table
"TE10" 10
"TE01" 15
"TM11" 18.0277563773199
"TE11" 18.0277563773199
"TE20" 20
"TM21" 25
"TE21" 25
"TE02" 30
"TE30" 30
"TM12" 31.6227766016838
"TE12" 31.6227766016838
"TM31" 33.5410196624968
"TE31" 33.5410196624968
"TM22" 36.0555127546399
"TE22" 36.0555127546399
"TE40" 40
"TM32" 42.4264068711929
"TE32" 42.4264068711929
"TM41" 42.7200187265877
"TE41" 42.7200187265877
Table_4 =
20×2 table
"TE10" 7.5
"TE01" 15
"TE20" 15
"TM11" 16.7705098312484
"TE11" 16.7705098312484
"TM21" 21.2132034355964
"TE21" 21.2132034355964
"TE30" 22.5
"TM31" 27.0416345659799
"TE31" 27.0416345659799
"TE02" 30
"TE40" 30
"TM12" 30.9232921921325
"TE12" 30.9232921921325
"TM22" 33.5410196624968
"TM41" 33.5410196624968
"TE22" 33.5410196624968
"TE41" 33.5410196624968
"TE50" 37.5
"TM32" 37.5
Table_5 =
20×2 table
"TE10" 6
"TE20" 12
"TE01" 15
"TM11" 16.1554944214035
"TE11" 16.1554944214035
"TE30" 18
"TM21" 19.2093727122985
"TE21" 19.2093727122985
"TM31" 23.43074902772
"TE31" 23.43074902772
"TE40" 24
"TM41" 28.3019433961698
"TE41" 28.3019433961698
"TE50" 30
"TE02" 30
"TM12" 30.5941170815567
"TE12" 30.5941170815567
"TM22" 32.310988842807
"TE22" 32.310988842807
"TM51" 33.5410196624968