15eel76 PSS Lab Manual
15eel76 PSS Lab Manual
15eel76 PSS Lab Manual
LABORATORY MANUAL
Semester: VII
Subject Code: 15EEL76
Regulation.
02 Determination of Power Angle Diagrams, Reluctance Power, Excitation, Emf and Regulation for Salient and
Non-Salient Pole Synchronous Machines
03 To obtain Swing Curve and to Determine Critical Clearing Time, Regulation, Inertia Constant/Line Parameters
/Fault Location/Clearing Time/Pre-Fault Electrical Output for a Single Machine connected to Infinite Bus through
a Pair of identical Transmission Lines Under 3-Phase Fault On One of the two Lines.
04 Y Bus Formation for Power Systems with and without Mutual Coupling, by Singular Transformation and
Inspection Method.
05 Formation of Z Bus (without mutual coupling) using Z-Bus Building Algorithm.
06 Determination of Bus Currents, Bus Power and Line Flow for a Specified System Voltage (Bus) Profile.
07 Formation of Jacobian for a System not Exceeding 4 Buses (No PV Buses) in Polar Coordinates.
Using Mi-Power
08 Load Flow Analysis using Gauss Siedel Method, NR Method and Fast Decoupled Method for Both PQ and PV
Buses.
09 To Determine Fault Currents and Voltages in a Single Transmission Line System with Star-Delta Transformers at
a Specified Location for LG and LLG faults by simulation.
10 Optimal Generation Scheduling for Thermal power plants by simulation.
Revised Bloom’s L1 – Remembering, L2 – Understanding, L3 – Applying, L4 – Analysing, L5 – Evaluating, L6 –
Taxonomy Level Creating.
Course outcomes: At the end of the course the student will be able to:
Develop a program in MATLAB to assess the performance of medium and long transmission lines.
Develop a program in MATLAB to obtain the power angle characteristics of salient and non-salient pole alternator.
Develop a program in MATLAB to assess the transient stability under three phase fault at different locations in a of
radial power systems.
Develop programs in MATLAB to formulate bus admittance and bus impedance matrices of interconnected power
systems.
Use Mi-Power package to solve power flow problem for simple power systems.
Use Mi-Power package to study unsymmetrical faults at different locations in radial power systems
Use of Mi-Power package to study optimal generation scheduling problems for thermal power plants.
Graduate Attributes (As per NBA)
Engineering Knowledge, Problem Analysis, Individual and Team work, Communication.
Conduct of Practical Examination:
1. All laboratory experiments are to be included for practical examination.
2. Breakup of marks and the instructions printed on the cover page of answer script to be strictly adhered by the examiners.
3. Students can pick one experiment from the questions lot prepared by the examiners.
4. Change of experiment is allowed only once and 15% Marks allotted to the procedure part to be made zero
Aim:
Determination of ABCD paratmeters for short transmission line with a given condition and
hence study the performance of the line regulation and efficiency.
Problem statement:
A 3-phase overhead transmission line deliver a 1100kw at 11kv at 0.8pf lagging the total
resistance and inductive reactance of the line are 8 ohm and 16 ohm respectively. Determine
1)Line current 2) Sending end voltage 3Sending end power factor 4)Sending end real power
5)Sending end reactive power 6)Transmission efficiency 7)Percentage regulation 8)ABCD
parameters.
Appartus required: Matlab software
Theory: Refer Principle of power system by V K Mehta & Rohit Mehta
Procedure:
Do the hand calculations and solve the problem.
Note down the theoretical results.
Double click on matlab icon in the desktop.
Type edit and press enter to get the Editor window.
Type the program.
Save and run the program.
Enter the inputs in the command window and see the output response.
Note down the simulated results.
Program
%short transmission line
clear;
clc;
R=input('resistance of the line in ohm=');
X=input('reactance of the line in ohm=');
VR3ph=input('voltage at receiving end in KV=');
PR=input('real load at receiving end in MW=');
QR=input('reactive load at receiving end in MVAR=');
Z=R+j*X;
ABCD=[1 Z;0 1];
VR=VR3ph/sqrt(3)+j*0;
SR=PR+j*QR;
IR=conj(SR)/(3*conj(VR));
VSIS=ABCD*[VR;IR];
VS=VSIS(1);
VS3ph=sqrt(3)*abs(VS);
IS=VSIS(2);
ISm=1000*abs(IS);
pfs=cos(angle(VS)-angle(IS));
SS=3*VS*conj(IS);
Reg=((VS3ph-VR3ph)/(VR3ph))*100;
Eff=PR/real(SS)*100;
fprintf('\n IS=%g A',ISm);
fprintf('\n pf=%g',pfs);
fprintf('\n VS=%g L-L KV',VS3ph);
fprintf('\n PS=%g MW',real(SS));
fprintf('\n QS=%g MVAR',imag(SS));
fprintf('\n percentage voltage regulation=%g',Reg);
fprintf('\n percentage transmission line efficiency=%g',Eff);
fprintf('\n ABCD parameters of transmission line\n');
disp(ABCD);
Inputs
resistance of the line in ohm=8
reactance of the line in ohm=16
voltage at receiving end in KV=11
real load at receiving end in MW=1.1
reactive load at receiving end in MVAR=0.825
Output response:
IS=72.1688 A
pf=0.751626
VS=13.0384 L-L KV
PS=1.225 MW
QS=1.075 MVAR
percentage voltage regulation=18.531
percntage transmission line Efficiency=89.7959
ABCD parameters of transmission line
1.0000 8.0000 +16.0000i
0 1.0000
Aim:
Determination of ABCD paratmeters for medium transmission line with a given condition
and hence study the performance of the line regulation and efficiency.
Problem statement 1:
A 3-phase 50Hz overhead tranmission line delivers 10 MW at 0.8pf lagging at 66 kV. The
resistance, inductive reactance and capacitive susceptance 10 ohm, 20 ohm and 4*10^-4
siemen. Determine 1)Sending end current 2)Sending end voltage 3)Sending end power factor
4)ABCD parameter 5) Regulation 6) Transmission effeciency using nominal T method.
Procedure:
Do the hand calculations and solve the problem.
Note down the theoretical results.
Double click on matlab icon in the desktop.
Type edit and press enter to get the Editor window.
Type the program.
Save and run the program.
Enter the inputs in the command window and see the output response.
Note down the simulated results.
Program:
%medium transmission line
clear;
clc;
R=input('resistance of the line in ohm=');
X=input('reactance of the line in ohm=');
B=input('susceptance of shunt line in mho=');
VR3ph=input('voltage at receiving end in KV=');
PR=input('real load at receiving end in MW=');
QR=input('reactive load at receiving end in MVAR=');
Z=R+j*X;
Y=0+j*B;
type=input('type(P-Pie/T-tmethod)=','s');
switch type
case'P'
ABCD=[1+Z*Y/2 Z;Y*(1+Z*Y/4) 1+Z*Y/2];
case'T'
ABCD=[1+Z*Y/2 Z*(1+Z*Y/4);Y 1+Z*Y/2];
otherwise
Error('Invaid type choosen!!!')
end
VR=VR3ph/sqrt(3)+j*0;
SR=PR+j*QR;
IR=conj(SR)/(3*conj(VR));
VSIS=ABCD*[VR;IR];
VS=VSIS(1);
VS3ph=sqrt(3)*abs(VS);
IS=VSIS(2);
ISm=1000*abs(IS);
Pfs=cos(angle(VS)-angle(IS));
SS=3*VS*conj(IS);
Reg=(VS3ph-VR3ph)/VR3ph*100;
Eff=PR/real(SS)*100;
fprintf('\n IS=%g A',ISm);
fprintf('\n Pfs=%g',Pfs);
fprintf('\n VS=%g L-L KV',VS3ph);
fprintf('\n PS=%g MW',real(SS));
fprintf('\n QS=%g MVAR',imag(SS));
fprintf('\n percentage voltage regulation=%g',Reg);
fprintf('\n percentage transmission line efficiency=%g',Eff);
fprintf('\n ABCD parameters of transmission line\n');
disp(ABCD);
Inputs:
resistance of the line in ohm=10
reactance of the line in ohm=20
voltage at receiving end in KV=66
real load at receiving end in MW=10
reactive load at receiving end in MVAR=7.5
susceptance of shunt line in mho=4e-4
type(P-Pie/T-tmethod)=T
Output response:
IS=100.533 A
Pfs=0.853122
VS=69.5439 L-L KV
PS=10.331 MW
QS=6.31771 MVAR
percentage voltage regulation=5.36958
percentage transmission line efficiency=96.7965
ABCD parameters of transmission line
0.9960 + 0.0020i 9.9600 +19.9700i
0 + 0.0004i 0.9960 + 0.0020i
Problem statement 2:
A 3-phase 50Hz overhead transmission line of 100 km has the following constants.
Resistance/km/phase=0.1 ohm
Inductive reactance/km/phase=0.5 ohm
Capacitive susceptance/km/phase=10*10^-5 siemen
The line supplies the load of 20MW at 0.9pf lagging at 66kV at receiving end.
Determine 1)Sending end current 2)Sending end voltage 3)Sending end power factor
4)ABCD parameter 5) Regulation 6) Transmission effeciency using nominal pi method.
Input:
resistance of the line in ohm=10
reactance of the line in ohm=50
susceptance of shunt line in mho=1e-3
voltage at receiving end in KV=66
real load at receiving end in MW=20
reactive load at receiving end in MVAR=9.67
type(P-Pie/T-tmethod)=P
Output response:
IS=176.475 A
Pfs=0.905904
VS=76.0096 L-L KV
PS=21.0471 MW
QS=9.83893 MVAR
percentage voltage regulation=15.166
percentage transmission line efficiency=95.0248
ABCD parameters of transmission line
0.9750 + 0.0050i 10.0000 +50.0000i
-0.0000 + 0.0010i 0.9750 + 0.0050i
Aim:
Determination of ABCD paratmeters for long transmission line with a given condition and
hence study the performance of the line regulation and efficiency.
Problem statement 1:
Determine the efficiency and regulation of 3-phase, 50Hz, 120km long transmission line
delivering 40MW at 132kV at 0.8 lagging pf with following details.
Resistance/km/phase=0.2 ohm
Inductive reactance/km/phase=1.3mH
Capactive susceptance/km/phase=0.01 micro farad
Procedure:
Do the hand calculations and solve the problem.
Note down the theoretical results.
Double click on matlab icon in the desktop.
Type edit and press enter to get the Editor window.
Type the program.
Save and run the program.
Enter the inputs in the command window and see the output response.
Note down the simulated results.
Program:
%long transmission line
clear;
clc;
R=input('resistance of the line in ohm=');
X=input('reactance of the line in ohm=');
B=input('susceptance of shunt line in mho=');
VR3ph=input('voltage at receiving end in KV=');
PR=input('real load at receiving end in MW=');
QR=input('reactive load at receiving end in MVAR=');
Z=R+j*X;
Y=0+j*B;
gamma=sqrt(Z*Y);
Zc=sqrt(Z/Y);
A=cosh(gamma);
B=Zc*sinh(gamma);
C=1/Zc*sinh(gamma);
D=A;
ABCD=[A B;C D];
VR=VR3ph/sqrt(3)+j*0;
SR=PR+j*QR;
IR=conj(SR)/(3*conj(VR));
VSIS=ABCD*[VR;IR];
VS=VSIS(1);
VS3ph=sqrt(3)*abs(VS);
IS=VSIS(2);
ISm=1000*abs(IS);
Pfs=cos(angle(VS)-angle(IS));
SS=3*VS*conj(IS);
Reg=(VS3ph-VR3ph)/VR3ph*100;
Eff=PR/real(SS)*100;
Val=(A*D)-(B*C);
fprintf('\n IS=%g A',ISm);
fprintf('\n Pfs=%g',Pfs);
fprintf('\n VS=%g L-L KV',VS3ph);
fprintf('\n PS=%g MW',real(SS));
fprintf('\n Qs=%g MVAR',imag(SS));
fprintf('\n percentage voltage regulation=%g',Reg);
fprintf('\n Efficiency=%g',Eff);
fprintf('\n A*D-B*C=%g',Val);
fprintf('\n ABCd parameters of transmission line\n');
disp(ABCD);
Inputs:
resistance of the line in ohm=24
reactance of the line in ohm=49.0088
susceptance of shunt line in mho=3.76e-4
voltage at receiving end in KV=132
real load at receiving end in MW=40
reactive load at receiving end in MVAR=30
Output response:
IS=200.922 A
Pfs=0.830052
VS=149.46 L-L KV
PS=43.1736 MW
Qs=29.007 MVAR
percentage voltage regulation=13.2272
Efficiency=92.6493
A*D-B*C=1
ABCd parameters of transmission line
0.9908 + 0.0045i 23.8528 +48.8944i
-0.0000 + 0.0004i 0.9908 + 0.0045i
Problem statement:
Obtain the Ybus by inspection method for the network shown in fig below.
Procedure:
Do the hand calculations and solve the problem.
Note down the theoretical results.
Double click on matlab icon in the desktop.
Type edit and press enter to get the Editor window.
Type the program.
Save and run the program.
Enter the inputs in the command window and see the output response.
Note down the simulated results.
Program:
%formation of Ybus by inspection
clear;
clc;
% en fb tb admittance
Ydata=[1 1 2 1.2
2 1 4 1.5
3 2 3 0.2
4 2 4 0.3
5 3 4 0.15];
bus=max(max(Ydata(:,2)),max(Ydata(:,3)));
element=max(Ydata(:,1));
Ybus=zeros(bus,bus);
for row=1:element;
i1=Ydata(row,2);
j1=Ydata(row,3);
if i1~=0&j1~=0
Ybus(i1,i1)=Ybus(i1,i1)+Ydata(row,4);
Ybus(j1,j1)=Ybus(j1,j1)+Ydata(row,4);
end
end
for k=1:element,
Ybus(Ydata(k,2),Ydata(k,3))=-Ydata(k,4);
Ybus(Ydata(k,3),Ydata(k,2))=-Ydata(k,4);
end
disp(Ybus);
Output response:
2.7000 -1.2000 0 -1.5000
-1.2000 1.7000 -0.2000 -0.3000
0 -0.2000 0.3500 -0.1500
-1.5000 -0.3000 -0.1500 1.9500
Problem statement:
For the system defined by the line data determine the YBus admittance matrix by singular
transformation method. Select bus no. 1 as reference bus and treat elements 6 & 7 as links.
Line data:
Element no 1 2 3 4 5 6 7
Bus code 1-6 2-6 2-5 1-3 3-4 4-5 3-6
Admittance 20j 35j 10j 5j 20j 10j 25j
Program:
% Ybus formation by singular transformation method
clear;
clc;
% en fb tb self adm. en mut adm.
Ydata=[1 1 6 20i 0 0
2 2 6 35i 0 0
3 2 5 10i 0 0
4 1 3 5i 0 0
5 3 4 20i 0 0
6 4 5 10i 0 0
7 3 6 25i 0 0];
element=max(Ydata(:,1));
buses=max(max(Ydata(:,2)),max(Ydata(:,3)));
buses=buses-1;
A=zeros(element,buses);
for i=1:element;
if(Ydata(i,2)~=1)A(i,Ydata(i,2)-1)=1;
end
if(Ydata(i,3)~=1)A(i,Ydata(i,3)-1)=-1;
end
end
% formation of primitive impedance matrix
Yprimitive=zeros(element,element);
for i=1:element,
Yprimitive(i,i)=Ydata(i,4);
if Ydata(i,5)>0,
Yprimitive(i,Ydata(i,5))=Ydata(i,6);
Yprimitive(Ydata(i,5),i)=Ydata(i,6);
end
end
Yprimitive=(Yprimitive);
Ybus=A'*Yprimitive*A;
fprintf('\n\t\t Bus admittance matrix\n');
disp(Ybus);
Output response:
Bus admittance matrix
0 +45.0000i 0 0 0 -10.0000i 0 -35.0000i
0 0 +50.0000i 0 -20.0000i 0 0 -25.0000i
0 0 -20.0000i 0 +30.0000i 0 -10.0000i 0
0 -10.0000i 0 0 -10.0000i 0 +20.0000i 0
0 -35.0000i 0 -25.0000i 0 0 0 +80.0000i
Problem statement:
Find Ybus for the power system given below by singular transformation method with mutual
coupling.
Line data:
Element no Self bus code Imp Zpq in pu Bus code Imp Zpq
1 1-2 0.6j - 0
2 1-3 0.5j 1-2 0.1j
3 3-4 0.5j - 0
4 1-2 0.4j 1-4 0.2j
5 2-4 0.2j - 0
Program:
% Ybus formation by singular transformation method
clear;
clc;
% en fb tb self imp en mut imp.
Zdata= [1 1 2 0.6 0 0
2 1 3 0.5 1 0.1
3 3 4 0.5 0 0
4 1 2 0.4 1 0.2
5 2 4 0.2 0 0];
elements=max(Zdata(:,1));
buses=max(max(Zdata(:,2)),max(Zdata(:,3)));
buses=buses-1;
A=zeros(elements,buses);
for i=1:elements,
if(Zdata(i,2)~=1)A(i,Zdata(i,2)-1)=1;
end
if(Zdata(i,3)~=1)A(i,Zdata(i,3)-1)=-1;
end
end
% formation of primitive impedance matrix
Zprimitive=zeros(elements,elements);
for i=1:elements,
Zprimitive(i,i)=Zdata(i,4);
if Zdata(i,5)>0,
Zprimitive(i,Zdata(i,5))=Zdata(i,6);
Zprimitive(Zdata(i,5),i)=Zdata(i,6);
end
end
Yprimitive=inv(Zprimitive);
Ybus=A'*Yprimitive*A;
fprintf('\n\t\t Bus admittance matrix\n');
disp(Ybus);
Output response:
Bus admittance matrix
8.0208 -0.2083 -5.0000
-0.2083 4.0833 -2.0000
-5.0000 -2.0000 7.0000
Problem statement:
Form the ZBus by building algorithm for the following network shown.
Procedure:
Do the hand calculations and solve the problem.
Note down the theoretical results.
Double click on matlab icon in the desktop.
Type edit and press enter to get the Editor window.
Type the program.
Save and run the program.
Enter the inputs in the command window and see the output response.
Note down the simulated results.
Program:
%Zbus building algorithm
clear;
clc;
% en fb tb self imp
Zprimary=[1 1 0 0.25
2 2 1 0.1
3 3 1 0.1
4 2 0 0.25
5 2 3 0.1];
[elements columns]=size(Zprimary);
Zbus=[];
currentbusno=0;
for i=1:elements,
[rows columns]=size(Zbus);
from=Zprimary(i,2);
to=Zprimary(i,3);
value=Zprimary(i,4);
newbus=max(from,to);
ref=min(from,to);
if newbus>currentbusno & ref==0
Zbus=[Zbus zeros(rows,1);
zeros(1,columns) value]
currentbusno=newbus;
continue
end
if newbus>currentbusno & ref~=0
Zbus=[Zbus Zbus(:,ref);
Zbus(ref,:) value+Zbus(ref,ref)]
currentbusno=newbus;
continue
end
if newbus<=currentbusno & ref==0
Zbus=Zbus-1/(Zbus(newbus,newbus)+value)*Zbus(:,newbus)*Zbus(newbus,:);
continue
end
if newbus<=currentbusno & ref~=0
Zbus=Zbus-1/(value+Zbus(from,from)+Zbus(to,to)-2*Zbus(from,to))*(Zbus(:,from)-
Zbus(:,to))*(Zbus(from,:)-Zbus(to,:));
continue
end
end
fprintf('\n Thus Zbus by building algorithm is \n');
disp(Zbus);
Output response:
Zbus =
0.2500
Zbus =
0.2500 0.2500
0.2500 0.3500
Zbus =
0.2500 0.2500 0.2500
0.2500 0.3500 0.2500
0.2500 0.2500 0.3500
Problem statement:
A 34.64 kV 60MVA synchronous generator has direct axis reactance 13.5 ohm and
quadratute axis reactance 9.33 ohm is operating at 0.8 pf. Determine the excitation emf,
regulation, non-salient power, reluctance power, salient power and also plot the power angle
curves for non-salient pole and salient pole synchronous machine.
Procedure:
Do the hand calculations and solve the problem.
Note down the theoretical results.
Double click on matlab icon in the desktop.
Type edit and press enter to get the Editor window.
Type the program.
Save and run the program.
Enter the inputs in the command window and see the output response.
Note down the simulated results.
Program:
%power angle curve
clear;
clc;
p=input('power in mw=');
pf=input('power factor=');
vt=input('line to line voltage in kv=');
xd=input('xd in ohms=');
xq=input('xq in ohms=');
vt_ph=vt*1000/sqrt(3);
pf_a=acos(pf);
q=p*tan(pf_a);
i=(p-j*q)*1000000/(3*vt_ph);
delta=0:1:180;
delta_rad=delta*(pi/180);
if xd==xq
%non salientsyn motor
ef=vt_ph+(j*i*xd);
excitation_emf=abs(ef)
reg=(abs(ef)-abs(vt_ph))*100/abs(vt_ph)
power_non=abs(ef)*vt_ph*sin(delta_rad)/xd;
net_power=3*power_non/1000000;
plot(delta,net_power);
xlabel('delta(deg)-->');
ylabel('three phase power(mw)->');
title('plot:power angle curve for non salient pole synchronous m/c');
legend('non salient power')
end
if xd~=xq
%salient syn motor
eq=vt_ph+(j*i*xq);
id_mag=abs(i)*sin(angle(eq)-angle(i));
ef_mag=abs(eq)+((xd-xq)*id_mag)
excitation_emf=ef_mag
reg=(ef_mag-abs(vt_ph))*100/abs(vt_ph)
pp=ef_mag*vt_ph*sin(delta_rad)/xd;
reluct_power=vt_ph^2*(xd-xq)*sin(2*delta_rad)/(2*xd*xq);
net_reluct_power=3*reluct_power/1000000;
power_sal=pp+reluct_power;
net_power_sal=3*power_sal/1000000;
plot(delta,net_reluct_power,'k');
hold on
plot(delta,net_power_sal,'r');
xlabel('delta(deg)-->');
ylabel('three phase power(pu)-->');
title('plot:power angle curve for salient pole synchronous m/c');
legend('reluct_power','salint_power')
end
grid;
Output response:
excitation_emf =
2.6664e+004
reg =
33.3222
Output response:
ef_mag =
3.0000e+004
excitation_emf =
3.0000e+004
reg =
50.0024
5. Swing curve
Aim:
Determination of swing curve and critical clearing time of the machine connected to infinite
bus.
Problem statement:
A 20MVA, 50Hz generator delivers 18MW over a double circuit line to an infinite bus. The
generator has kinetic energy of 2.52 MJ/MVA at rated speed. The generator transient
reactance is Xd’=0.35pu. Each transmission circuit has R=0 and a reactance of 0.2pu on a
20MVA base. ׀E’= ׀1.1pu and infinite bus voltage V=1.0 at 0 degree. A three phase short
circuit occurs at the mid point of the transmission lines. Plot swing curves with fault cleared
by simultaneous opening of breakers at both ends of the line at 2.5 cycles and 6.25 cycles
after the occurrence of fault. Also plot the swing curve over the period of 0.5 seconds if the
fault is sustained.
Theory: Refer the modern power system analysis by D P Kothari & I J Nagarth
Procedure:
Do the hand calculations and solve the problem.
Note down the theoretical results.
Double click on matlab icon in the desktop.
Type edit and press enter to get the Editor window.
Type the program.
Save and run the program.
Enter the inputs in the command window and see the output response.
Note down the simulated results.
Program:
%swing curve
clear;
clc;
t=0;
tf=0;
tfl=0.5;
tc=0.05; %tc=0.05,0.125,0.5 sec for 2.5cycles,6.25cycle & 25cycle resp
ts=0.05;
m=2.52/(180*50);
i=2;
dt=21.64*pi/180;
ddt=0;
time(1)=0;
ang(1)=21.64;
pm=0.9;
pm1=2.44;
pm2=0.88;
pm3=2.00;
while t<tfl,
if (t==tf),
pam=pm-pm1*sin(dt);
pap=pm-pm2*sin(dt);
paav=(pam+pap)/2;
pa=paav;
end
if (t==tc),
pam=pm-pm2*sin(dt);
pap=pm-pm3*sin(dt);
paav=(pam+pap)/2;
pa=paav;
end
if (t>tf&t<tc),
pa=pm-pm2*sin(dt);
end
if (t>tc),
pa=pm-pm3*sin(dt);
end
ddt=ddt+(ts*ts*pa/m);
dt=(dt*180/pi+ddt)*pi/180;
dtdg=dt*180/pi;
t=t+ts;
time(i)=t;
ang(i)=dtdg;
i=i+1;
end
axis([0 0.6 0 160])
plot(time,ang,'k+-')
title('swing curve for fault cleared in 2.5 cycles')
Table B:
Bus no Bus voltage Generation Load
MW MVAR MW MVAR
1 1.05+0j - - - -
2 - 0 0 400 250
3 1.04+0j 200 - 0 0
Appartus required: Mipower software
Theory: Refer the modern power system analysis by D P Kothari & I J Nagarth & mipower
software manual.
Procedure:
Do the hand calculations and solve the problem.
Note down the theoretical results.
Double click on mipower icon in the desktop.
Creat the database with .mdb extension.
Draw the one line diagram.
Save and simulate.
Note the results.
Problem statement 2:
Figure below shows the one line diagram of a simple three bus system with generator at bus
1. The voltage at bus 1 is 1∟0º unit. The scheduled loads on buses 2 & 3 are marked on the
diagram. Line impedances are marked in pu on a base of 100 MVA. Using GS method with
initial estimate of V2=V3=1∟0º. Conduct load flow analysis.
Problem statement:
The 3 bus system is given below. The line parameters are given in table A and generator data
are given in table B. Line impedances are marked in pu and line charging susceptances are
neglected. Taking bus no.1 as a reference bus obtain the load flow analysis.
Table A:
Bus code Impedance in pu
1-2 0.08+0.24j
1-3 0.02+0.06j
2-3 0.06+0.18j
Table B:
Bus no Bus voltage
Generation Load
MW MVAR MW MVAR
1 1.05+0j - - - -
2 - - - 50 20
3 - - - 60 25
Appartus required: Mipower software
Theory: Refer the modern power system analysis by D P Kothari & I J Nagarth & mipower
software manual.
Procedure:
Do the hand calculations and solve the problem.
Note down the theoretical results.
Double click on mipower icon in the desktop.
Creat the database with .mdb extension.
Draw the one line diagram.
Save and simulate.
8. Fault analysis
Aim:
To determine the fault current and voltage in a single tranmssion line system for the
following Y-∆ transformer at specified location for LG, LLG faults.
Problem statement:
For the given circuit find the fault current, voltage for the following type of the faults at bus-3
i)LG fault
ii)LLG fault
for the tranmission line assume X1=X2=0.4 and X0=2.5XL
Result:
SLGF Voltage angle Phase (mag) angle
(mag)
At Bus 3 0.0731 0.04 0 -54.39
0.281 179.9 1.126 -129.54
0.478 -179.9 1.263 -124.68
Problem statement:
The cost equations and loss co-efficients of different units in the plant are given. Determine
economic generation for total load demand of 240MW.
Theory: Refer the modern power system analysis by D P Kothari & I J Nagarth & mipower
software manual.
Procedure:
Do the hand calculations and solve the problem.
Note down the theoretical results.
Double click on mipower icon in the desktop.
In Tools Chose Economic dispatch by B Coefficients.
Create a new file with .bci extension.
Enter the details.
Save and Execute.
Note the results.
Result:
Initial total generation cost 8928.0000 Rs
Final cost of generation at generator 1=2807.234673 Rs for 83.098 MW
Final cost of generation at generator 2=3099.9999 Rs for 100.00 MW
Final cost of generation at generator 3=2582.1636 Rs for 72.8274 MW
Final total generation cost is Rs 8489.3984