You are on page 1of 23

EXPT NO:1 DATE:

COMPUTATION OF PARAMETERS AND MODELLING OF


TRANSMISSION LINES

AIM
(i) To determine the positive sequence line parameters L and C per phase per kilometer of
a three phase single and double circuit transmission lines for different conductor
arrangements.
(ii) To understand modelling and performance of short, medium and long lines.

OBJECTIVES
i. To become familiar with different arrangements of conductors of a three phase single
and double circuit transmission lines and to compute the GMD and GMR for different
arrangements.
ii. To compute the series inductance and shunt capacitance per phase, per km of a three
phase single and double circuit overhead transmission lines with solid and bundled
conductors.
iii. To become familiar with per phase equivalent of a three phase short and medium lines
and to evaluate the performances for different load conditions.
iv. (a) To become familiar with the theory of long transmission line and study the effect of
distributed parameters on voltage and currents, along the line, (b) calculate the surge
Impedance and surge impedance loading.

3Φ - Symmetrical Spacing: 3Φ - Asymmetrical Transposed: Nominal П-Model:

Bundle conductors:

EXERCISES:

1
Formulae:
a. Transmission line parameters L and C calculation:

1. Single circuit 3 phase line


Inductance/phase/km = 2x10-1 xln(Dm/Ds) (mH/km)
where
Dm is mutual GMD
Ds is self GMD
Dm = (d1d2d3)1/3
Ds = 0.7788xr
Capacitance/phase/km = 2xπx8.854*10-3 / ln(Dm/Ds)(µf/km)
Dm = (d1d2d3)1/3
Ds = r

2. Double circuit 3 phase line


Inductance/phase/km = 2x10-1 xln(Dm/Ds) (mH/km)
where
Dm is mutual GMD
Ds is self GMD
Dm = (DAB xDBC xDCA)1/3
Ds = (DS1 xD S2 xD S3)1/3
DAB = (DabxDab’xDa’bxDa’b’)1/4
DBC = (DbcxDbc’xDb’cxDb’c’)1/4
DCA = (DcaxDca’xDc’axDc’a’)1/4
DS1 = (DaaxDaa’xDa’axDa’a’)1/4
DS2 = (DbbxDbb’xDb’bxDb’b’)1/4
DS3 = (DccxDcc’xDc’cxDc’c’)1/4
Daa = Da’a’ = Dbb = Db’b’ = Dcc =Dc’c’=0.7788xr
Capacitance/phase/km = 2xπx8.854*10-3 / ln(Dm/Ds)(µf/km)
Dm is same as inductance
Daa = Da’a’ = Dbb = Db’b’ = Dcc =Dc’c’=r

b. Modelling of transmission lines:


When receiving end data given:
Vr(Φ) = Vr(line)/√3
Ir(Φ) = P(3Φ)/(√3 x Vr(line)xcosΦ
ZY
A= 1+ =D
2
For nominal π model
B=Z
ZY
C = Y(1 + )
4
For nominal T model
C=Y
ZY
B = Z(1 + )
4
Vs(Φ) = AVr(Φ)+B Ir(Φ)
Is(Φ) = CVr(Φ)+D Ir(Φ)
V
( As )−Vr(Φ)
% Voltage Regulation = x100;
Vr(∅)
ph=angle(Vs) - angle(Is);
2
Ps (3Φ)=3xVsxIsxcos(ph)
Pr(3Φ)
% Transmission line efficiency = x100;
Ps(3Φ)

when sending end data given


Vs(Φ) = Vs(line)/√3
IsΦ) = P(3Φ)/(√3 x Vs(line)xcosΦ
ZY
A= 1+ =D
2
For nominal π model

B=Z
ZY
C = Y(1 + )
4
For nominal T model
C=Y
ZY
B = Z(1 + )
4
Vr(Φ) = DVs(Φ)-B Is(Φ)
Ir(Φ) = -CVs(Φ)+A Is(Φ)
V
( As )−Vr(Φ)
% Voltage Regulation = x100;
Vr(Φ)
ph=angle(Vr) - angle(Ir);
Pr (3Φ)=3xVrxIrxcos(ph)
Pr(3Φ)
% Transmission line efficiency = x100;
Ps(3Φ)

EXERCISE:
1.Find the inductance and capacitance per km of a 3 phase transmission line using
1.24 cm diameter conductors when these are placed at the corners of an equilateral
triangle of each side 2 m.

2. The three conductors of a 3 phase transmission line are arranged at the corners of
a triangle of sides 2m, 2.5m and 4.5m. Calculate the inductance and capacitance
per km of the line when the conductors are regularly transposed. The diameter of
each conductor is 1.24 cm.

3. Find the inductance and capacitance per km of double circuit 3 phase


transmission line shown in Figure. The conductors are transposed and are of
radius 0.75 cm each. The phase sequence is ABC.

3
4. A 230 kV, 60 HZ three phase transmissions is 160 km long. The per phase resistance
is 0.124 Ω per km and the reactance is 0.497 Ω per km and the shunt
admittance is 3.30 x 10-6∟900seimens per km It delivers 40MW at 220 KV with
0.9 power factor lagging. Use medium line П model. Determine the voltage and
current at sending end and also compute voltage regulation and efficiency and verify
the results using the available program.

5. A three phase transmission line has a per phase impedance of Z=0.03+j0.04 Ω per
km and a per phase shunt admittance of y=j4.0 x 10-6 Siemens per km. The line is
200 km long. Obtain ABCD parameters of the transmission line. The line is sending
407 MW and 7.833 MVAR at 350 kV. Use medium П model. Determine the voltage
and current at sending end and also compute voltage regulation and efficiency.

INPUT FILE:

1. To determine the positive sequence line parameters L and C


clear all;
clc;
n=menu('Option','Single Circuit 3 phase line', 'Double Circuit 3 phase
line');
if(n==1)
r=input('\nenter the value of radius of conductor in metre \n');
d1=input('\nenter the value of spacing between phase A and B in metre
\n');
d2=input('\nenter the value of spacing between phase B and C in metre
\n');
d3=input('\nenter the value of spacing between phase C and A in metre
\n');
Dm=(d1*d2*d3)^(1/3);
Ds=0.7788*r;
L=2*10^-7*log(Dm/Ds);
m=double(L);
Ds=r;
C=2*pi*8.854*10^-3/log(Dm/Ds);
k=double(C);
fprintf('Inductance value is %d mH/km\n', m)
fprintf('Capacitance value is %d µF/km\n', k)
end
if(n==2)
r=input('\nenter the value of radius of conductor in metre \n');
D_aadash=input('\nenter the value of distance between a and a dash
conductors in metre \n');
D_bbdash=input('\nenter the value of distance between b and b dash
conductors in metre \n');
D_ccdash=input('\nenter the value of distance between c and c dash
conductors in metre \n');
D_ab=input('\nenter the value of distance between a and b conductors in
metre \n');
D_abdash=input('\nenter the value of distance between a and b dash
conductors in metre \n');
D_ac=input('\nenter the value of distance between a and c conductors in
metre \n');
D_acdash=input('\nenter the value of distance between a and c dash
conductors in metre \n');
D_bc=input('\nenter the value of distance between b and c conductors in
metre \n');
D_bcdash=input('\nenter the value of distance between b and c dash
conductors in metre \n');

4
GMD=0.7788*r;
Ds1=sqrt(GMD*D_aadash);
Ds2=sqrt(GMD*D_bbdash);
Ds3=sqrt(GMD*D_ccdash);
Ds=(Ds1*Ds2*Ds3)^(1/3)
DAB=sqrt(D_ab*D_abdash);
DBC=sqrt(D_bc*D_bcdash);
DCA=sqrt(D_ac*D_acdash);
Dm=(DAB*DBC*DCA)^(1/3)
L=2*10^-7*log(Dm/Ds);
p=double(L);
fprintf('Inductance value is %d mH/km\n', p)
GMD=r;
Ds1=sqrt(GMD*D_aadash)
Ds2=sqrt(GMD*D_bbdash)
Ds3=sqrt(GMD*D_ccdash)
Ds=(Ds1*Ds2*Ds3)^(1/3)
C=2*pi*8.854*10^-3/(log(Dm/Ds));
q=double(C);
fprintf('Capacitance value is %d µF/km\n', q)
end

2. Modelling of transmission lines

n=menu('option','Receiving End Data Given','Sending End Data Given')


if(n==1)
j=sqrt(-1);
i=sqrt(-1);
t=menu('Receiving End Data Given', 'Nominal pi model','nominal T model')
R=input('\nenter the value of resistance \n');
X=input('\nenter the value of reactancee \n');
Z=R+i*X
G=input('\nenter the value of conductance \n');
B=input('\nenter the value of susceptance \n');
Y=G+i*B
Pr=input('\nenter the value of 3 phase load power \n');
Vr=input('\nenter the line value of receiving end voltage \n');
pf=input('\nenter the value of power factor \n');
ph=acos(pf);
A=1+(Z*Y/2)
D=A
if (t==1)
B=Z
C=Y*(1+(Z*Y/4))
end
if(t==2)
C=Y
B=Z*(1+(Z*Y/4))
end
Vr1=Vr/sqrt(3)
Ir=Pr/(sqrt(3)*Vr*pf);
Ir=Ir*(pf-j*sin(ph))
[angIr magIr]=cart2pol(real(Ir),imag(Ir))
Vs=A*Vr1+B*Ir;
Is=C*Vr1+D*Ir;
[angVs magVs]=cart2pol(real(Vs),imag(Vs))
[angIs magIs]=cart2pol(real(Is),imag(Is))
Vsline=magVs*sqrt(3);
Vso=magVs/A
[angVso magVso]=cart2pol(real(Vso),imag(Vso));
reg=((magVso-Vr1)/Vr1)*100;
ph1=angVs-angIs;

5
Ps=3*magVs*magIs*cos(ph1)
eff=(Pr/Ps)*100;
fprintf('\nSending end line voltage is %d \n',double(Ps))
fprintf('\nRegulation is %3.4f \n', reg)
fprintf('\nEfficiency is %3.4f \n', eff)
end
if(n==2)
j=sqrt(-1);
i=sqrt(-1);
t=menu('Receiving End Data Given', 'Nominal pi model','nominal T model')
R=input('\nenter the value of resistance \n');
X=input('\nenter the value of reactancee \n');
Z=R+i*X
G=input('\nenter the value of conductance \n');
B=input('\nenter the value of susceptance \n');
Y=G+i*B
Ps=input('\nenter the value of 3 phase sending end power \n');
Vs=input('\nenter the line value of sending end voltage \n');
pf=input('\nenter the value+ of power factor \n');
ph=acos(pf);
A=1+(Z*Y/2)
D=A
if(t==1)
B=Z
C=Y*(1+(Z*Y/4))
end
if(t==2)
C=Y
B=Z*(1+(Z*Y/4))
end
Vs1=Vs/sqrt(3)
Is=Ps/(sqrt(3)*Vs*pf);
Is=Is*(pf-j*sin(ph))
[angIs magIs]=cart2pol(real(Is),imag(Is))
Vr=D*Vs1-B*Is;
Ir=-C*Vs1+A*Is;
[angVr magVr]=cart2pol(real(Vr),imag(Vr))
[angIr magIr]=cart2pol(real(Ir),imag(Ir))
Vrline=magVr*sqrt(3);
Vso=Vs1/A
reg=((Vso-magVr)/magVr)*100;
ph1=angVr-angIr;
Pr=3*magVr*magIr*cos(ph1)
eff=(Pr/Ps)*100;
fprintf('\nreceiving end line voltage is %3.4f \n', Vrline)
fprintf('\nRegulation is %3.4f \n', reg)
fprintf('\nEfficiency is %3.4f \n', eff)
end

6
INFERENCE:

RESULT:

The positive sequence line parameters L & C per phase per km were calculated manually
and the results were verified using the AU software and modeling of transmission lines
for short, medium and long length also were performed.

7
EXPT NO: 2 DATE:

FORMATION OF BUS ADMITTANCE AND IMPEDANCE


MATRICES

AIM:
To understand the formation of network matrices, the bus admittance matrix Y and
the bus impedance matrix Z of a power network.

OBJECTIVE:

i. To write a computer program to form bus admittance matrix Y, given the


impedances of the elements of a power network and their connectivity
(mutual coupling between elements neglected)
ii. To obtain the impedance matrix Z.

EXERCISE:
1.) Using a text editor create an input file in the sequence given below for formation of
Y matrix for the 6-bus system. Check the results obtained using the available
Software.

SYSTEM DATA
NO OF BUSES : 6 NO OF TRANSMISSION LINES: 5
NO OF TRANSFORMERS : 2 NO OF SHUNT ELEMENTS : 2
SYSTEM BASE MVA : 100.00

TRANSMISSION LINE DATA


L NO S BUS R BUS R_IN_PU X_IN_PU HBC_IN_PU RAT
1 1 6 .1230 .5180 .0000 55.0000
2 1 4 .0800 .3700 .0000 65.0000
3 4 6 .0870 .4070 .0000 30.0000
4 5 2 .2820 .6400 .0000 55.0000

8
5 2 3 .7230 1.0500 .0000 40.0000
TRANSFORMER DATA

TNO S BUS R BUS R_IN_PU X_IN_PU TAP_IN_PU RAT


1 6 5 .0000 .3000 1.0000 30.0000
2 4 3 .0000 1330 1.0000 55.0000

SHUNT CAP/REACTOR DATA


S NO BUS NO SHUNT_MVAR
1 4 2.0000
2 6 2.5000

9
2.

10
INPUT FILE

clc;
n=input ('Enter the number of buses :');
for i=1:n
for j=1:n
if (i==j)
y(i,j)=0;
a(i,j)=0;
else
i
j
z(i,j)=input('Enter self impedance:');
if(z(i,j)==0)
y(i,j)=z(i,j);
else
y(i,j)=1/z(i,j);
end
a(i,j)=input('Enter the half line charging admittance:');
end
end
end
for i=1:n
for j=1:n
if(i==j)
R(i,j)=0;
for k=1:n
R(i,j)=y(i,k)+a(i,k)+R(i,j);
end
else
R(i,j)=-y(i,j);
end
end
end
disp('The resultant y-bus is:');
R
z=inv(R)

11
INFERENCE:

RESULT:

Thus the Y-BUS and Z-BUS matrices are formed using MATLAB software and
verified with theoretical calculation

12
EXPERIMENT 3 DATE:

LOAD FLOW ANALYSIS - I : SOLUTION OF LOAD FLOW AND RELATED


PROBLEMS USING GAUSS-SEIDEL METHOD

AIM:
(i) To understand, the basic aspects of steady state analysis of power systems that are
required for effective planning and operation of power systems.
(ii) To understand, in particular, the mathematical formulation of load flow model in
complex form and a simple method of solving load flow problems of small sized system
using Gauss-Seidel iterative algorithm

OBJECTIVES:
To write a computer program to solve the set of non-linear load flow equations using
Gauss-Seidel Load Flow (GSLF) algorithm and present the results in the format required
for system studies.

EXERCISE:
1. The Fig. shows the one line diagram of a simple 3 bus power system. The
scheduled loads at buses 2 and 3 are as marked on the diagram. Line
impedances are marked in p.u. on a 100 MVA base. Find out the bus
voltages and slack bus power after two iterations using Gauss-Seidal
method. Take acceleration factor has 1.6

MATLAB INPUT FILE:

clc;
x=input('Enter the number of elements:');
a=0;
y=0;
for e=1:x
i= input('Enter the starting node:');
j=input('Enter the ending node:');
y(e,e)=input('Enter the admittance value:');
y(e,e)=1/y(e,e);
a(e,i)=1;
a(e,j)=-1;
end
ybus=a'*y*a;
ybus
b=input('Enter the number of buses:');
for i=2:b

13
i
pg(i)= input ('Enter the generator power in MW:');
qg(i)= input ('Enter the generator power in MVAR:');
pL(i)= input ('Enter the load in MW:');
qL(i)= input ('Enter the load in MVAR:');
p(i)=pg(i)-pL(i);
q(i)=qg(i)-qL(i);
end
v(1)=input('Enter the slack bus voltage:');
acc=input('Enter the acceleration factor:');
for i=2:b
i

v(i)=input('Enter the voltage:');


c(i)=input('Enter the phase angle:');

v(i)=v(i)*(exp(1i*(c(i)*(pi/180))));
v(i)

end
n=input('Enter the number of iterations');
for i=1:n
for j=2:b
L(j)=0;
for k=1:b
if(j~=k)
L(j)=L(j)+(ybus(j,k)*v(k));
end
end
s(j)=v(j);
v(j)=((((p(j)-(1i*q(j)))/conj(v(j)))-L(j))/ybus(j,j));
v(j)=s(j)+acc*(v(j)-s(j));
end
end
for i=1:b
disp('bus');
i
disp('Voltage:');
v(i)
end

14
INFERENCE:

RESULT:

Thus the basic aspect of steady state analysis of power system that are required for effective
planning and operation of power system are understood. Thus the mathematical formulation
of load flow models in the complex form and simple method of solving load problem
of small size system using Gauss – Seidal iterative algorithm were implemented.

15
EXPT NO: 4 DATE:

LOAD FLOW ANALYSIS-:II SOLUTION OF LOAD FLOW AND RELATED


PROBLEMS USING NEWTON-RAPHSON METHOD

AIM:
(i) To understand the following for medium and large scale power systems.
a) Mathematical formulation of load flow problem in real variable form.
b) Newton Raphson method of load flow (NRLF) solution.
c) Fast decoupled method of load flow (FDLP) solution.
(ii) To become proficient in the usage of software for practical problem solving in the
areas of power system planning and operation.
(iii) To become proficient in the usage of software in solving problems using Newton-
Raphson and Fast decoupled load flow methods.

OBJECTIVES:
(i) To investigate the convergence characteristics of load flow solutions using
NRLF and FDLP algorithms for different sized systems and compare the same
with that of GSLF algorithm.
(ii) To investigate the effect of variation of voltage control parameters such as
generator voltage magnitude setting, off nominal tap ratio of transformer and
MVAR injections of shunt capacitors/inductor on the voltage profile and
transmission loss of the system.
(iii) To assess the effect of single outage contingencies such as a line outages and
generator outages.

EXERCISE:

1. The Fig. shows the one line diagram of a simple 3 bus power system. The scheduled
loads at buses 2 and 3 are as marked on the diagram. Line impedances are marked in
p.u. on a 100 MVA base. Find out the bus voltages and slack bus power after two
iterations using NRLF and FDLF method.

16
PROGRAM:
clear all;
clc;
n=input('enter the number of buses:');
for i=1:n
for j=i:n
yb(i,j)=input(['Enter the y bus matrix
elements',num2str(i),num2str(j),':']);
yb(j,i)=yb(i,j);
end
end
for i=1:n
mag(i)=input(['Enter the voltage magnitude of bus',num2str(i),':']);
th(i)=input(['Enter the angle of bus',num2str(i),':']);
acp(i)=input(['Enter the real power of bus',num2str(i),':']);
acq(i)=input(['Enter the reactive power of bus',num2str(i),':']);
end
my=abs(yb);
an=angle(yb);
g=real(yb);
b=imag(yb);
for i=1:n
pe(i)=0;
qu(i)=0;
for j=1:n
pe(i)=mag(i)*my(i,j)*mag(j)*cos(th(i)-th(j)-an(i,j))+pe(i);
qu(i)=mag(i)*my(i,j)*mag(j)*sin(th(i)-th(j)-an(i,j))+qu(i);
end
end
for i=2:n
for j=2:n
if i~=j
j1(i,j)=mag(i)*mag(j)*(g(i,j)*sin(th(i)-th(j))-
b(i,j)*cos(th(i)-th(j)));
j3(i,j)=-mag(i)*mag(j)*(g(i,j)*cos(th(i)-
th(j))+b(i,j)*sin(th(i)-th(j)));
j2(i,j)=-j3(i,j);
j4(i,j)=-j1(i,j);
else
j1(i,j)=-qu(i)-b(i,j)*(mag(i)^2);
j2(i,j)=pe(i)+g(i,j)*(mag(i)^2);
j3(i,j)=pe(i)-g(i,j)*(mag(i)^2);
j4(i,j)=qu(i)-b(i,j)*(mag(i)^2);
end
end
end
ja1(1:n-1,1:n-1)=j1(2:n,2:n);
ja2(1:n-1,1:n-1)=j2(2:n,2:n);
ja3(1:n-1,1:n-1)=j3(2:n,2:n);
ja4(1:n-1,1:n-1)=j4(2:n,2:n);
jacob=[ja1 ja2;ja3 ja4];
disp('the jacobian matrix is:')
disp(jacob);
delp(1:n-1)=acp(2:n)-pe(2:n);
delq(1:n-1)=acq(2:n)-qu(2:n);
chan=(inv(jacob))*[delp delp]';
chth(2:n)=chan(1:2);
chma(2:n)=chan(n:2*2);
for i=2:n
chmag(i)=chma(i)*mag(i);
end
mag=mag+chmag;
th=th+chth;

17
disp(['The voltage magnitudes are;',num2str(mag),])
disp(['The phase values are;',num2str(th),])

18
INFERENCE:

RESULT

The load flow solution is obtained for the given 6 bus 5 line power system using Newton
Raphson and Fast Decoupled Load Flow methods and contingency analysis also
conducted.

19
EXPT NO: 5 DATE:
FAULT ANALYSIS
AIM:
To become familiar with modeling and analysis of power system under faulted condition
and to compute the fault level post fault voltage and current for different types of fault both
symmetrical and unsymmetrical.

OBJECTIVES:
1. To carryout fault analysis for symmetrical and unsymmetrical faults in small systems
using the Thevenin’s equivalent circuit in the sequences and phase domains at the
faulted bus but without the use of software.
2. To conduct fault analysis on a given system using software available and obtain fault
analysis report with fault level and current at the faulted point and post-fault voltages
and currents in the network for the following faults
(a) Three-phase-to-ground
(b) Line-to-ground
(c) Line-to-Line
(d) Double-line-to-ground

FORMULAE:
1. Balanced three phase fault
If=Vpf/Z1+Zf;
2. Single line to ground fault
Ia1=Vpf/(Z1+Z2+Z0+3*Zf);
If=3*Ia1;
3. Line to line fault
Ia1=Vpf/(Z1+Z2+Zf);
If=-j*√3*Ia1;
4. Line to line fault with ground

Ia1=Vpf/(Z1+((Z2*(Z0+3*Zf))/(Z2+Z0+3*Zf)));
Ia0=-Ia1*(Z2/(Z2+Z0+3*Zf));
If=3*Ia0;
where
Vpf is the prefault voltage
Z1 is the positive sequence impedance of the system in p.u.
Z2 is the negative sequence impedance of the system in p.u.
Z0 is the zero sequence impedance of the system in p.u.
Zf is the fault impedance in p.u.

20
EXERCISE:
1. It is proposed to conduct fault analysis on two alternative configurations of 4-bus system
given in fig shown below.

G1, G2: 100MVA, 20KV, x+ = x- =xd” = 20%; x0=4%; xn = 5%


T1, T2: 100MVA, 20KV/345KV; xleak = 8%
L1, L2: x+=x-=15%; x0=50% on the base of 100MVA
The first configuration, case (a), comprises star-star transformers and the second
configuration, case(b), comprises star-delta transformers.
For a three phase to ground (solid) fault, line to line fault, line to ground fault, double line|
to ground fault at bus 4, determine the fault current and MVA at faulted bus, post fault bus
voltages, fault current distribution in different elements of the network using Thevenin
equivalent circuit. Draw a single-line diagram showing the above results.

MATLAB INPUT FILE:


If=0;
j=sqrt(-1);
vpf=1+j*0;
Z1=input('enter the positive sequence impedance of the system in p.u. =
');
Z1=j*Z1;
Z2=input('enter the negative sequence impedance of the system in p.u. =
');
Z2=j*Z2;
Z0=input('enter the zero sequence impedance of the systemin p.u. = ');
Z0=j*Z0;
Zf=input('Enter the fault impedancein p.u. = ');
Zf=j*Zf;
Ib=input('Enter the base current = ');
ft=menu('option','Three Phase Fault','LG Fault','LL Fault','LLG Fault')
if(ft==1)
If=vpf/Z1+Zf;
If_magnitude_in_perunit=abs(If)
If_magnitude_in_acutualvalue=Ib*abs(If)
If_angle=(180/pi)*angle(If)
end
if(ft==2)
Ia1=vpf/(Z1+Z2+Z0+3*Zf);
If=3*Ia1;
If_magnitude_in_perunit=abs(If)
If_magnitude_in_acutualvalue=Ib*abs(If)
If_angle=(180/pi)*angle(If)
end
if(ft==3)
Ia1=vpf/(Z1+Z2+Zf);

21
If=-j*sqrt(3)*Ia1;
If_magnitude_in_perunit=abs(If)
If_magnitude_in_acutualvalue=Ib*abs(If)
If_angle=(180/pi)*angle(If)
end
if(ft==4)
Ia1=vpf/(Z1+((Z2*(Z0+3*Zf))/(Z2+Z0+3*Zf)));
Ia0=-Ia1*(Z2/(Z2+Z0+3*Zf));
If=3*Ia0;
If_magnitude_in_perunit=abs(If)
If_magnitude_in_acutualvalue=Ib*abs(If)
If_angle=(180/pi)*angle(If)
end

22
INFERENCE:

RESULT:

The modeling and analysis of power system under faulted condition were studied and fault
level, post fault voltages and current for different types of fault both symmetrical and
unsymmetrical were computed using MATLAB software.

23

You might also like