282
282
Name:S.B.N.VENKSTESWARARAO
SEC-E
Fig.1
Program/Matlab Code:
clc
clear all
close all
x = linspace(-4,4,100);
y = linspace(-4,4,100);
z = linspace(-4,4,100);
[X, Y, Z] = meshgrid(x, y, z);
Ex = sin(2*pi*(Z/3));
Ey = 0*X;
Ez = 0*X;
[Bx, By, Bz] = curl(X, Y, Z, Ex, Ey, Ez);
for k=1:100
E(k) = mean(mean(Ex(:,:,k),1),2);
B(k) = mean(mean(By(:,:,k),1),2);
end
plot3(0*x, y, E, 'red', 'LineWidth', 2); hold on
quiver3(0*x(1:3:100), y(1:3:100), 0*z(1:3:100), 0*x(1:3:100), 0*y(1:3:100), E(1:3:100),
0,'r','lineWidth', 1.5);
hold on
plot3(B, y, 0*z, 'g','LineWidth', 2);
quiver3(0*x(1:3:100), y(1:3:100), 0*z(1:3:100), B(1:3:100), 0*y(1:3:100), 0*z(1:3:100), 0,
'g', 'lineWidth', 1.5);
grid on, axis square
set(gca, 'FontSize', 15, 'lineWidth',2);
xlabel('x');
ylabel('y');
zlabel('z');
Maxwell’s first equation is based on the Gauss law of electrostatic, which states that “when a
closed surface integral of electric flux density is always equal to charge enclosed over that
surface”
Gauss Law
Gauss law describes the nature of the electric field around electric charges. The law is
expressed in terms of electric charge density and electric charge density. The inverted triangle
is called the divergence operator.
The equations hold well at any point in space. When the electric charge exists somewhere,
the divergence of D at that particular point is nonzero, else it is zero.
Gauss law on magnetostatics states that “closed surface integral of magnetic flux density is
always equal to total scalar magnetic flux enclosed within that surface of any shape or size
lying in any medium.”
You need to be familiar with Gauss Law for the electric field to understand this
equation. You can see that both equations indicate the divergence of the field. The top
equation states that the divergence of the electric flux density D equals the volume of electric
charge density.
The second equation states the divergence of the Magnetic Flux Density (B) is null.
Statement: Time-varying magnetic field will always produce an electric field. Maxwell’s 3rd
equation is derived from Faraday’s laws of Electromagnetic Induction. It states that “Whenever
there are n-turns of conducting coil in a closed path placed in a time-varying magnetic field, an
alternating electromotive force gets induced in each coil.” Lenz’s law gives this. Which states,”
An induced electromotive force always opposes the time-varying magnetic flux.”
Faraday’s Law
Fig.2
Faraday was a scientist whose experiment setup led to Faraday’s Law which is shown in the
above figure .2. The experiment is not very complex. When a battery is disconnected, no
electricity flows through the wire. Hence, no magnetic flux is induced in the iron (Magnetic
Core). The iron acts like a magnetic field that flows easily in a magnetic material. The purpose
of the core is to form a path for the flow of magnetic flux.
Ampere’s Law
The law shows the relationship between the flow of electric current and the magnetic field
around it. Suppose the wire carries a current I, the current produces a magnetic field that
surrounds the wire.
clc;
close all;
clear all;
mu0 = pi*4E-7;
AmpereB = @(m0u,I,r) (mu0.*I)./(2*pi*r);
radius = linspace(1E-3, 1);
I = 1;
Figure (1)
semilogy(radius, AmpereB(mu0,I,radius))
grid
xlabel('r (m)')
ylabel('B')
% Plotting
figure;
quiver(X, Y, Bx, By, 'b'); % Plot magnetic field vectors
hold on;
quiver(X, Y, Ex, Ey, 'r'); % Plot electric field vectors
title('Electric and Magnetic Field Flux Lines');
xlabel('x');
ylabel('y');
axis tight;
Program/Matlab Code:
Iclc;
clear all;
close all;
% Parameters
c0 = 3e8; % Speed of light in vacuum (m/s)
delta = 1e-3; % Spatial step size (m)
dt = delta/c0; % Time step size (s)
T = 2000; % Total number of time steps
L = 400; % Total number of spatial steps
% Initialization
Ex = zeros(T, L); % Electric field in x-direction
Hy = zeros(T, L); % Magnetic field in y-direction
for x = 2:L-1
% Update electric field (Ex) using Ampere's law with the conductivity
Ex(t, x) = Ex(t-1, x) + (Hy(t, x) - Hy(t, x-1)) * dt * c0 / delta;
Ex(t, x) = Ex(t, x) - (sigma * dt / (eps0)) * Ex(t, x);
end
end
figure;
surf(X, T, Ex);
shading flat;
colormap jet;
xlabel('Distance (m)');
ylabel('Time (s)');
zlabel('Electric Field (V/m)');
title('Wave Propagation in a Conducting Medium');
Exp 5
Theory:
Explaining Wave Propagation in Lossless Media:
A lossless medium is a medium with zero conductivity and finite permeability and
permittivity. When an electromagnetic wave propagates through a lossless medium, the
amplitude of its electric field or magnetic field remains constant throughout the propagation.
The properties of the lossless medium affect the speed of propagation, and it is reduced by a
factor of 1/ ( √𝝁r𝜺r) compared to the speed of the electromagnetic waves in the vacuum. A
lossless medium for electromagnetic waves is a medium with
zero conductivity (𝞂)
finite permeability (𝝁)
permittivity(𝜺).
It can be described using the equation below:
Consider a plane wave propagating in the y-direction, with electric and magnetic fields
mutually perpendicular to each other and to the wave propagation. A set of wave equations
are used to define the electromagnetic waves:
The general solution to the linear, homogenous second order differential equations can be
given in equations 4 and 5.
From the above equations, we can conclude that other than the field amplitudes, E1, E2, H1,
and H2, the electromagnetic wave characteristics of the fields are identical. Characteristics of
the electromagnetic waves defined by the general field solutions can be determined by
investigating the corresponding instantaneous electric or magnetic fields. Taking this into
consideration, the time-domain solution of the wave equation in terms of the electric field can
be represented by equation 6.
In the equation, 𝛂 is the attenuation constant, 𝛃 is the phase constant, and 𝛚 is the angular
velocity of propagation.
Explaining Wave Propagation in Lossy Dielectrics:
A lossy dielectric can be described as a medium where some fraction of the
electromagnetic wave power is lost as the wave propagates. This power loss is due to poor
conduction. A lossy dielectric offers a partially conducting medium with conductivity 𝜎≠0.
The lossy dielectric can be represented with the conductivity, permeability, and permittivity
parameters as follows:
By taking the curl on both sides of equations (3) and (4), we can obtain Helmholtz’s
equations or the wave equations given by equations (5) and (6), respectively.
Substituting equation (10) into equation (5), the scalar wave equation is:
According to the assumption that the field must be finite at infinity, E,0 =0. Equation (11) can
be rewritten using factor e-𝛼z as:
From equation (12), the magnitude of E versus t can be plotted. Only the x component of E
travels along the +z direction. H(z,t) can also be obtained in a similar way, and can be given
as:
Program/Matlab Code:
clc;
clear all;
close all;
t=0:0.0005:5;
z=0:0.0005:5;
eta=377;
theta=pi/2;
E0=50;
a=0;
u=1.256*(10.^-6);
e=8.854*(10.^-12);
f=600000000;
w=2*pi*f;
b=w*((u*e).^0.5);
E=E0/eta;
H=E*exp(-a*z).*cos(w*t-b*z-theta);
Ez=E0*exp(-a*z).*cos(w*t-b*z);
figure(1);
subplot(211),plot(z,H,'r');
xlabel('Dispalcement(metres)');
ylabel('Magnetic Field Intensity(H)');
title('Plane wave propagation in Lossy medium');
subplot(212),plot(z,Ez,'g');
xlabel('Dispalcement(metres)');
ylabel('Electric Field Intensity(E)');
title ('Plane wave propagation in Lossy medium');