Experiment All DD
Experiment All DD
Experiment All DD
Experiment - 1
Aim :To write computer program for plotting instantaneous voltage, current and
power in a single phase ac circuit.
Matlab Code :
%plotting P Q S V and I in single phase ac circuit
%f=50Hz, pf angle varying from -90 to 0 to +90
Vm=1;
Im=0.5;
f=50;
theta=[-pi/2:.1:pi/2];
t=[0:0.001:.02];
wt=2*pi*f.*t;
pdc=((Vm*Im)/2).*cos(theta)
% v=Vm*sin(wt)
% i=Im*sin(wt-theta(i))
% plot(t,v,t,i)
for j=1:length(theta)
v=Vm.*sin(wt)
i=Im*sin(wt-theta(j))
s=v.*i
p=(((Vm*Im)/2).*cos(theta(j)))*(1-cos(2.*wt))
q=((((Vm*Im)/2).*sin(theta(j))).*sin(2.*wt))
pdc=((Vm*Im)/2).*cos(theta(j))
pdc=pdc*(ones(length(v)))
plot(t,v,t,i,t,s,t,p,t,q,t,pdc)
grid on
legend('V','I','S','P','Q','DC')
pause()
end
Output Plot :
Conclusion :
Experiment - 2
Aim : To write computer program and obtain voltage regulation and efficiency of short
transmission line for different specified set of receiving end quantities (different load at
leading, unity and lagging power factor)
MATLAB Code :
A=1;
B=Z;
C=0;
D=A;
Ir=S/((sqrt(3)*Vl));
IR =((Ir))*complex(cos(-acos(Fi)),sin(-acos(Fi)));
VS=A*Vr+B*IR;
IS=C*Vr+D*IR;
Ps=3*real(VS*(conj(IS)));
VR=(((abs(VS))-(abs(Vr)))/(abs(Vr)))*100;
Pr=S*0.8;
EF=(Pr/Ps)*100;
Qs=3*imag(VS*(conj(IS)));
F=cos(atan(Qs/Ps));
fprintf('\n')
disp('Receiving end Line Voltage in kV');
disp(((abs(Vr)*(sqrt(3))))/1000);
disp('Receiving end current');
disp(abs(IR))
Output :
Example 1 :
Example 2:
Conclusion:
Experiment - 3
Aim : To write computer program and obtain voltage regulation and efficiency of a
Medium transmission line T model for different specified set of receiving end quantities.
Output
Example : 1
Length of transmission line in km
100
freq. in hz
50
receiving end voltage in kv (Enter line Value)
66
Per km resistance in ohm
0.1
Per km reactance in ohm
0.2
per km susuptance in siemens
0.04e-4
Receiving end power in kw
10000
value fi0.8
Example:02
0.2
Per km reactance in ohm
0.4
per km susuptance in siemens
2.5e-6
Receving end power in kw
20000
value fi0.9
Conclusion:
Experiment - 4
Aim : To write computer program and obtain voltage regulation and efficiency of a Medium
transmission line π model for different specified set of receiving end quantities
Matlab Code :
%% Medium Line by Pi model
clc;
clear all;
L=input('Length of transmission line in km\n ');
Vl=input('receiving end voltage in kv\n ');
r=input('Per km resistance in ohm\n ');
l=input('Per km inductance in mH\n ');
P=input('Receiving power in MW\n ');
Fi=input('Lagging power factor\n ');
S=(P/Fi)*(10^6);
Vl=Vl*(10^3);
l=l*(10^-3);
ind=L*(l);
R=r*(L);
Vr=Vl/sqrt(3);
Z=complex(R,2*pi*50*ind);
j=sqrt(-1);
c=input('Per km capacitance in uF\n ');
c=c*(10^-6);
Y=2*pi*50*c*L*j;
A=(Y/2)*Z+1;
B=Z;
C=Y*(((Y/4)*Z)+1);
D=A;
Ir=S/((sqrt(3)*Vl));
IR =((Ir))*complex(cos(-acos(Fi)),sin(-acos(Fi)));
VS=A*Vr+B*IR;
IS=C*Vr+D*IR;
Ps=3*real(VS*(conj(IS)));
VR=(((abs(VS))-(abs(Vr)))/(abs(Vr)))*100;
Pr=S*0.8;
EF=(Pr/Ps)*100;
Qs=3*imag(VS*(conj(IS)));
F=cos(atan(Qs/Ps));
fprintf('\n')
disp('Receiving end Line voltage in kV');
disp(((abs(Vr)*(sqrt(3))))/1000)
disp('Receiving end current');
disp(abs(IR))
disp('Sending end Line voltage in kV');
disp(((abs(VS)*(sqrt(3))))/1000)
disp('Receiving end current');
disp(abs(IS))
disp('Sending end p.f.');
disp(F)
disp('Voltage Regulation of the line');
disp(VR)
disp('Transmission Efficiency of the line');
disp(EF)
Output :
Example 10.13:
Example 10.14:
1.59
Receiving power in MW
20
Lagging power factor
.9
Per km capacitance in uF
.0318
Conclusion:
EXPERIMENT - 5
AIM : To Analise the performance of long transmission line for specified load impedance.
Matlab Code :
%% Long Transmission Line
clc;
clear all;
L=input('Length of transmission line in km\n ');
Vl=input('receiving end voltage in kV\n');
r=input('Per km resistance in ohm\n');
l=input('Per km inductance in mH\n');
P=input('Receiving power in MW\n');
Fi=input('Lagging power factor\n');
S=(P/Fi)*(10^6);
Vl=Vl*(10^3);
l=l*(10^-3);
ind=L*(l);
R=r*(L);
Vr=Vl/sqrt(3);
Z=complex(R,2*pi*50*ind);
j=sqrt(-1);
c=input('Per km capacitance in uF\n ');
c=c*(10^-6);
Y=2*pi*50*c*L*j;
K=sqrt(Y*Z);
M=sqrt(Y/Z);
A=cosh(K);
B=sinh(K)/M;
C=M*sinh(K);
D=A;
Ir=S/((sqrt(3)*Vl));
IR =((Ir))*complex(cos(-acos(Fi)),sin(-acos(Fi)));
VS=A*Vr+B*IR;
IS=C*Vr+D*IR;
Ps=3*real(VS*(conj(IS)));
VR=(((abs(VS))-(abs(Vr)))/(abs(Vr)))*100
Pr=S*0.8;
EF=(Pr/Ps)*100;
Qs=3*imag(VS*(conj(IS)));
F=cos(atan(Qs/Ps));
fprintf('\n')
Output :
Example -1
VR =
10.8163
Example-2
VR =
10.8195
Conclusion:
Experiment - 6
Aim : To simulate transient in series R-L circuit with special attention to change in DC
offset current for application of excitation at different instant.
Theory:
Transient Response of Series RL Circuit having DC Excitation is also called as First order
circuit. In this article we discuss about transient response of first order circuit i.e. series R-L
circuit, its derivation with example.
Let a d.c. voltage V be applied suddenly (i.e., at t=0) by closing a switch K in a series R-L
circuit as shown in figure 1.
or
or
where ic is the complementary function that always goes to zero value in a relatively short
time (transient solution) and is given by being a constant; ip is the particular solution of i that
provides the steady state response.
An inductance, due to its “electrical inertia” does not allow sudden change of current
through it following the rules of electromagnetic induction and hence at current through it
just before switching is same to the current just after the switching. This is represented as
However, before switching, there was no current through the inductor and hence at time
t=0+ (i.e., just after switching) the current through the inductor will also be zero.
i.e.,
with the initial condition, equation (3) at t=0+ becomes
This gives,
or
Expression (4) clearly shows the exponential rise of current i charging the inductor. The
profile i vs t has been shown in figure 2.
Scope output
Conclusion:
EXPERIMENT NO.:07
Aim : To develop program for formulation of ZBUS matrix through ZBUS building
algorithm.
Theory :
By inventing Ybus
Jbus = Ybus Vbus
Or Vbus = [Ybus]^-1 Jbus = Zbus Jbus
Or Zbus = [Ybus]^-1
The sparsity of Ybus, may be retained by using an efficient inversion technique [1] and nodal
impedance matrix can then be calculated directly from the factorized admittance matrix.
This is beyond the scope of this book.
Zb=branch impedance
Zbus (old) Zbus
Upon adding a new branch, one of the following situations is presented.
Matlab Code :
clear all;
clc
disp('------Formulation Z-bus Matrix-------')
n=input('enter total number of busses including Ref
busses = ');
zbus=zeros(n,n);
t=1;
while t==1
zbus;
s=menu('specify case no','new bus to reference
bus','existing bus to new bus','between existing
busses','existing bus to reference
bus','print','quit');
switch s
case{1}
zb=input('enter impedance value = ');
zbus=zb;
case{2}
k=input('enter starting bus number = ');
n=input('enter new bus number = ');
zb=input('Enter impedance value = ');
for i=1:n
if i==n
zbus(n,n)=zbus(k,k)+zb;
else
zbus(i,n)=zbus(i,k);
zbus(n,i)=zbus(k,i);
end
end
case{3}
a=input('enter first bus number = ');
b=input('enter second bus number = ');
zb=input('enter impedance value = ');
m1=zb+zbus(a,a)+zbus(b,b)-(2*zbus(a,b));
ztemp=(1/m1)*((zbus(:,a))-
(zbus(:,b)))*((zbus(a,:))-(zbus(b,:)));
zbus=zbus-ztemp;
case{4}
k=input('enter the old bus no = ');
zb=input('enter the impedance value = ');
m2=zbus(k,k)+zb;
ztemp=(1/m2)*zbus(:,k)*zbus(k,:);
zbus=zbus-ztemp;
case{5}
zbus;
case{6}
'end program';
t=0;
end
end
Experiment - 8
THEORY :
As stated earlier, the effects of line capacitance are neglected for a short transmission line.
Therefore, while studying the performance of such a line, only resistance and inductance of
the line are taken into account. The equivalent circuit of a single phase short transmission line
is shown in Fig.
I = load current
R= loop resistance i.e, resistance of both conductors
XL= loop reactance
VR= receiving end voltage
cosΦr = receiving end power factor ( lag)
VS = sending end voltage
cosΦs = sending end power factor
Phasor diagram of the line for lagging load power factor is shown in fig
( 0C )2 = ( 0D )2 + ( DC )2
V2S = ( 0E+ ED )2 + ( DB + BC )2
= ( VR cosΦR + IR )2 + ( VR sin ΦR + IXL )2
= √ [ (VR cosΦR + IR2 ) + ( VR sin ΦR + IXL )2 ]
0C = 0F = 0A + AF = 0A + AG + GF
= OA + AG + BH
VS= VR + IR cos ΦR + I XL sin ΦR
Conclusion:
Experiment - 9
THEORY:
In short transmission line calculations , the effect of the line capacitance are neglected
because such lines have smaller lengths and transmit power at relatively low voltage
(< 20 kV >). However ,as the length and voltage of the line increase ,the capacitance
gradually becomes of greater importance. Since medium transmission line have sufficient
length ( 50- 150 km ) and usually operate at voltages greater than 20kv ,the effect of
capacitance cannot be neglected . therefore ,in order to obtain reasonable accuracy in
medium transmission line calculations, the line capacitance must be taken into
consideration .
The capacitance is uniformly distributed over the entire length of the line . however , in
order to make the calculation simple , the line capacitance is assumed to be lumped or
concentrated in the from of capacitor shunted across the line at one or more points . such
treatment of localizing the line capacitance gives reasonably accurate results . the most
commonly used methods for the solution of medium transmission lines are ;
In this method the capacitance of the line is lumped or concentrated at the receiving or load
end as shown in fig .this method of localizing the line capacitance at the load end
overestimates the effects of capacitance . 3 – phase transmission line is shown as it is more
convenient to work in phase instead of line to line values .
VR = VR + j0
IR= IR (cosΦR - j sin ΦR )
IC = j VR w C = J 2 𝜋 f C VR
EXPERIMENT - 10
AIM : To Annalise the performance of long transmission line for specified load
impedance.
>Here we consider infinitely small length dx of the line at a distance x from receiving end .
>Consider a small element in the line of length dx situated at a distance x from the receiving
end.
>Let, z = series impedance of the line per unit length
> y = shunt admittance of the line per unit length
> v = voltage at the end of element to wards receiving end
> v = voltage at the end of element towards sending end
> I=di = current entering the element dx
> I= current leaving the element dx
> for the small element dx
> z dx = series impedance
> y dx = shut admittance
> rise in voltage over the element length in the direction of increasing x,
dv = I. Z dx
dv/dx = I.Z
> The current entering the element is ( I+dI) where as the current leaving the element is I.
the dIfference in the current dI flow through the shunt admittance of the line,
DI = v.y dx, current drawn by element,
di/dx = v.y
> Differentiating equation
d^2V/dx^2 = z dI/dx =z(vy)
d^2V/dx^2 = YZV
> The solution of this differential equation is
V = k1 cosh(x√𝑦𝑧)+k2 sinh(x√𝑦𝑧)
> Differentiating equation w.r.t x, we have,
dv/dx=k1√𝑦𝑧 sinh (x√𝑦𝑧)+ k2 √𝑦𝑧 cosh (x√𝑦𝑧)
dv/dx= I.z
I.z = k1 √𝑦𝑧 sinh (x√𝑦𝑧)+ k2√𝑦𝑧 cosh (x√𝑦𝑧)
I = √y/z [k1 sinh (x √𝑦𝑧) + k2 cosh (x√𝑦𝑧)
Equation and give the expressions for V and I in the form of unknown constants k1 and k2.
The values of k1 can be found by applying end conditions as under:
At x = 0, V=R and I =IR
VR = receiving end voltage
IR = receiving end current
Putting these values in equation we have
VR = k1 cosh 0 +k2 sinh 0 =k1 + 0
VR= k1
Putting x =0 v =vr and I = Ir in equation we have
IR= √y/z [k1 sinh 0 + k2 cos h 0] = √y/z [0+k2]
K2 =√z/y Ir
Substituting the value of k1 and k2 in equation we get,
V=Vr cosh (x√𝑦𝑧)+√z/y Ir sinh (x√𝑦𝑧)
And I =√𝑦𝑧 Vr sinh (x√𝑦𝑧) + Ir cosh (x√𝑦𝑧)
The sending end voltage (Vs) and sending end current (Is) are obtained by putting x= in the
above equation I.e.,
> Comparing question with the general voltage and current equation of the line, we have
A = cosh yl
B = Zc sinh yl
C = 1/Zc sinh yl
D = cosh yl
Conclusion: