Psa Manual (1) Merged
Psa Manual (1) Merged
Submitted in VII Semester in partial fulfillment for the award of the degree of
BACHELOR OF ENGINEERING
IV Year / 07 SEMESTER
Name : ________________________________
Register No. : ________________________________
SRI VENKATESWARAA COLLEGE OF TECHNOLOGY
Vadakal Village, Pondur Post, Sriperumbudur 602 105
BONAFIDE CERTIFICATE
5 FAULT ANALYSIS
ELECTROMAGNETIC TRANSIENTS IN
8
POWER SYSTEMS.
5. FAULT ANALYSIS
AIM :
(i) To determine the positive sequence line parameters L and C per phase per kilometre of a three
phase single and double circuit transmission lines for different conductor arrangements.
THEORY :
Transmission line has four parameters – resistance, inductance, capacitance and conductance.
The inductance and capacitance are due to the effect of magnetic and electric fields around the
conductor. The resistance of the conductor is best determined from the manufactures data, the
inductances and capacitances can be evaluated using the formula.
Inductance:
The general formula:
L = 0.2 ln (Dm / Ds)
Where,
Dm = geometric mean distance (GMD)
Ds = geometric mean radius (GMR)
I. Single phase 2 wire system
GMD = D
-1/4
GMR = re = r′
Where, r = radius of conductor
GMD = D
-1/4
GMR = re = r′
Where, r = radius of conductor
2
GMR = n √ (Daa Dab……. D an )…….(D na Dnb …….D nn)
(-1/ 4)
where, r′a = ra e
Bundle Conductors:
The GMR of bundle conductor is normally calculated GMR for two sub
1/2 b
conductor c = (Ds * d) GMR for three sub conductor D s
2 1/3
=(Ds * d )
b 3 1/4
GMR for four sub conductor Ds = 1.09 (Ds * d )
where, Ds is the GMR of each subconductor and d is bundle spacing
Three phase – Double circuit transposed:
PROCEDURE:
1. Enter the command window of the MATLAB.
2. Create a new M – file by selecting File - New – M – File
3. Type and save the program in the editor window.
4. Execute the program by either pressing Tools – Run.
5. View the results.
EXERCISES: .
A three phase overhead line 200km long R = 0.16 ohm/km and Conductor diameter of 2cm with spacing
4,5,6m transposed.Find A,B,C,D constants ,sending end voltage,current ,power factor and power when the
line is delivering full load of 50MW at 132kV ,0.8 pf lagging , transmission efficiency , receiving end voltage
and regulation.
PROGRAM :
clc;
ab=input('value of ab');
bc=input('value of bc');
ca=input('value of ca');
pr=input('receving end power in mw');
vr=input('receving end voltage in kv');
pfr=input('receving end powerfactor');
l=input('length of the line in km');
r=input('resistance/ph/km'); f=input('frequency');
D=input('diameter in m'); rad=D/2; newrad=(0.7788*rad); deq=(ab*bc*ca)^(1/3);
L=2*10^(-7)*log(deq/newrad);
C=(2*pi*8.854*10^-12)/log(deq/rad); XL=2*pi*f*L*l*1000;
rnew=r*l;
Z=rnew+i*(XL); Y=i*(2*pi*f*C*l*1000); A=1+((Y*Z)/2);
D=A;
B=Z; C=Y*(1+(Y*Z)/4);
vrph=(vr*10^3)/1.732; irold=(pr*10^6)/(1.732*vr*10^3*.8); k=sin(acos(pfr));
ir=irold*(pfr-(j*k)); vs=((A*vrph)+(B*ir)); is=((C*vrph)+(D*ir));
angle(vs); angle(is); f=angle(vs); u=angle(is); PFS=cos(f-u);
eff=((pr*10^6)/(3*abs(vs)*abs(is)*PFS))*100; reg=(((abs(vs)/abs(A))-
abs(vrph))/abs(vrph))*100;
L
C
rnew
A
B
C
abs(vs)
abs(is)
angle(vs)*180/pi
angle(is)*180/pi
PFS
eff
reg
OUTPUT:
value of ab4
value of bc5
value of ca6
receving end power in mw50
receving end voltage in kv132
receving end powerfactor0.8
length of the line in km200
resistance/ph/km0.16
frequency50
diameter in m0.02
L = 1.2902e-006
C = -2.5419e-006 +5.5725e-004i
rnew = 32
A = 0.9772 + 0.0090i
B = 32.0000 +81.0657i
C = -2.5419e-006 +5.5725e-004i
ans = 9.5677e+004
ans = 244.2088
ans = 7.9105
ans = -28.3157
PFS = 0.8067
eff = 88.4248
reg = 28.4694
MANUAL CALCULATIONS :
RESULT:
Thus the positive sequence line parameters L and C per phase per kilometre of a three
phase single and double circuit transmission lines for different conductor arrangements were
determined and verified with MATLAB software.
FORMATION OF BUS ADMITTANCE AND IMPEDANCE MATRICES
Expt.No :
Date :
AIM
To determine the bus admittance and impedance matrices for the given power system
network.
SOFTWARE REQUIRED: MATLAB 7.9
THEORY
FORMATION OF Y BUS MATRIX
Bus admittance is often used in power system studies. In most of the power system
studies it is required to form y- bus matrix of the system by considering certain power
system parameters depending upon the type of analysis.
OUTPUT:
Enter the No of bus3
Enter the impedence b/w 1&0 1j
Enter the impedence b/w 1&2 0.4j
Enter the impedence b/w 1&3 0.2j
Enter the impedence b/w 2&3 0.2j
Enter the impedence b/w 2&0 0.8j
Enter the impedence b/w 3&0 0.08j
Ybus=
y=
0 - 7.5000i 0 + 2.5000i 0 + 5.0000i
0 + 2.5000i 0 - 7.5000i 0 + 5.0000i
0 + 5.0000i 0 + 5.0000i 0 -22.5000i
z=
0 + 0.2300i 0 + 0.1300i 0 + 0.0800i
0 + 0.1300i 0 + 0.2300i 0 + 0.0800i
0 + 0.0800i 0 + 0.0800i 0 + 0.0800i
MANUAL CALCULATIONS:
RESULT:
Thus the bus Impedance and admittance matrix for the given system were determined
and verified using MATLAB.
SOLUTION OF POWER FLOW USING GAUSS-SEIDEL METHOD
Expt.No :
Date :
AIM :
To understand, in particular, the mathematical formulation of power flow model in complex form
and a simple method of solving power flow problems of small sized system using Gauss-Seidel
iterative algorithm
SOFTWARE REQUIRED: MATLAB 7.9
THEORY:
The GAUSS – SEIDEL method is an iterative algori thm for solving a set of non-linear load
flow equations.
The non-linear load flow equation is given by
n
1 Pp – j Q p p-1
k+1
k+1 k
Vp = - ∑ YpqVq - ∑ YpqVq
k*
Ypp (Vp ) q=1 q=p+1
p-1 n
k+1 k* k+1 k
QP =(-1) x Im (Vp ) ∑ Ypq Vq + ∑ Ypq Vq
q=1 q=p
PROCEDURE:
1. Enter the command window of the MATLAB.
2. Create a new M – file by selecting File - New – M – File
3. Type and save the program in the editor Window
4. Execute the program by either pressing Tools – Run.
5. View the results.
Algorithm for GSLF:
Step1: Read the input data
Step2: Find the admittance matrix
Step3: Choose the flat voltage profile 1+j*0
Step4: set the iteration count p=0 and bus count i=1
Step5: check the slack bus, if it is the generator bus then go to the next step otherwise go
to step7.
Step6: Before the check for the slack bus if it is slack bus then go to step11 otherwise go
to next step.
Step7: Check the reactive power of the generator bus within the given limit.
Step8: If the reactive power violates a limit then treat the bus as load bus.
Step9: Calculate the phase of the bus voltage on load bus.
Step10: Calculate the change in bus voltage of the repeat step mentioned above until all
the bus voltages are calculated.
Step11: Stop the program and print the results.
EXERCISE :
The figure shows the single line diagram of a simple 3 buses power system with generator at bus 1.The
magnitude at bus 1 is adjusted to 1.05pu. The scheduled loads at buses 2 and 3 are marked on the diagram.
Line impedance are marked in pu. The base value is 100MVA. The line charging susceptances are
neglected. Determine the phasor values of the voltage at the load buses 2 and 3. Find the slack bus real and
reactive power.
Verify the result using MATLAB.
Program:
%Gauss Sedial
clc;
data=[1 1 2 10-j*20
2 1 3 10-j*30
3 2 3 16-j*32]
elements=max(data(:,1));
bus=max(max(data(:,2)),max(data(:,3)));
y=zeros(bus,bus);
for p=1:bus,
for q=1:elements,
if(data(q,2)==p|data(q,3)==p)
y(p,p)=y(p,p)+data(q,4);
end
end
end
for p=1:bus,
for q=1:bus,
if (p~=q)
for r=1:elements
if((data(r,2)==p&data(r,3)==q)|(data(r,2)==q&data(r,3)==p))
y(p,q)=-(data(r,4));
end
end
end
end
end
a1=input('enter p2 in MW:');
b1=input('enter q2 in MVAR:');
a2=input('enter p3 in MW:');
b2=input('enter q3 in MVAR');
pu=input('enter the base value in MVA');
p2=(a1/pu);
q2=(b1/pu);
p3=(a2/pu);
q3=(b2/pu);
dx1=1+j*0;
dx2=1+j*0;
v1=1.05;
v2=1+j*0;
v3=1+j*0;
iter=0;
disp('iter v2 v3');
while(abs(dx1)&abs(dx2)>=0.00001)&iter<7;
iter=iter+1;
g1=(((p2-j*q2)/conj(v2))+(-y(1,2)*v1)+(-y(2,3)*v3))/y(2,2);
g2=(((p3-j*q3)/conj(v3))+(-y(1,3)*v1)+(-y(2,3)*g1))/y(3,3);
dx1=g1-v2;
dx2=g2-v3;
v2=v2+dx1;
v3=v3+dx2;
fprintf ('%g',iter),disp([v2,v3]);
end
OUTPUT:
data =
1.0000 1.0000 2.0000 10.0000 -20.0000i
2.0000 1.0000 3.0000 10.0000 -30.0000i
3.0000 2.0000 3.0000 16.0000 -32.0000i
enter p2 in MW:256.16
enter q2 in MVAR:110.2
enter p3 in MW:136.6
enter q3 in MVAR45.2
enter the base value in MVA100
iter v2 v3
1 1.0559 + 0.0309i 1.0661 + 0.0328i
N
QP = Σ fp (eq Gpq + fq Bpq) - ep (fq Gpq - eq Bpq)
q=1
2 2 2
Vp = ep + fp
EXERCISE
1. 1. Consider the 3 bus system each of the 3 line bus a series impedance of 0.02 + j0.08 p.u and a total shunt
admittance of j0.02 pu. The specified quantities at the buses are given below :
Bus Real load Reactive Load Real power Reactive Power Voltage
demand, PD demand, QD generation,PG Generation, QG Specified
1 2 1 - - V1=1.04
2 0 0 0.5 1 Unspecified
PROGRAM:
%NEWTON RAPHSON METHOD
clc;
gbus = [1 2.0 1.0 0.0 0.0
2 0.0 0.0 0.5 1.0
3 1.5 0.6 0.0 0.0];
ybus = [5.882-j*23.528 -2.941+j*11.764 -2.941+j*11.764
-2.941+j*11.764 5.882-j*23.528 -2.941+j*11.764
-2.941+j*11.764 -2.941+j*11.764 5.882-j*23.528];
t= 0.001
v1=1.04+j*0;
v2=1+j*0;
v3=1.04+j*0;
del3=angle(v3);
del1=angle(v1);
del2=angle(v2);
%abs(ybus(2,1))
%abs(v2)
for i=1:10
p2=(abs(v2)*abs(v1)*abs(ybus(2,1))*cos((angle(ybus(2,1)))+....
del1-del2))+abs(v2)*abs(v2)*abs(ybus(2,2))*cos((angle(ybus(2,2))))+....
(abs(v2)*abs(v3)*abs(ybus(2,3))*cos((angle(ybus(2,3)))+del3-del2));
q2=-(abs(v2)*abs(v1)*abs(ybus(2,1))*sin((angle(ybus(2,1)))+del1-del2))-....
abs(v2)*abs(v2)*abs(ybus(2,2))*sin((angle(ybus(2,2))))-(abs(v2)*....
abs(v3)*abs(ybus(2,3))*sin((angle(ybus(2,3)))+del3-del2));
p3=(abs(v3)*abs(v1)*abs(ybus(3,1))*cos((angle(ybus(3,1)))+del1-....
del3))+abs(v3)*abs(v3)*abs(ybus(3,3))*cos((angle(ybus(3,3))))+....
(abs(v2)*abs(v3)*abs(ybus(3,2))*cos((angle(ybus(3,2)))+del2-del3));
delp20=gbus(2,4)-gbus(2,2)-p2;
delp30=gbus(3,4)-gbus(3,2)-p3;
delq20=gbus(2,5)-gbus(2,3)-q2;
J(1,1)=(abs(v2)*abs(v1)*abs(ybus(2,1))*sin((angle(ybus(2,1)))+del1-
del2))+(abs(v2)*abs(v3)*abs(ybus(2,3))*sin((angle(ybus(2,3)))+del3-del2));
J(1,2)=-(abs(v2)*abs(v3)*abs(ybus(2,3))*sin((angle(ybus(2,3)))+del3-del2));
J(1,3)=(abs(v1)*abs(ybus(2,1))*cos((angle(ybus(2,1)))+del1-
del2))+2*(abs(v2)*abs(ybus(2,2))*cos((angle(ybus(2,2))))+(abs(v3)*abs(ybus(2,3))*cos
((angle(ybus(2,3)))+del3-del2)));
J(2,1)=-(abs(v3)*abs(v2)*abs(ybus(3,2))*sin((angle(ybus(3,2)))+del2-del3));
J(2,2)=(abs(v3)*abs(v1)*abs(ybus(3,1))*sin((angle(ybus(3,1)))+del1-
del3))+(abs(v3)*abs(v2)*abs(ybus(3,2))*sin((angle(ybus(3,2)))+del2-del3));
J(2,3)=(abs(v3)*abs(ybus(3,2))*cos((angle(ybus(3,2)))+del2-del3));
J(3,1)=(abs(v2)*abs(v1)*abs(ybus(2,1))*cos((angle(ybus(2,1)))+del1-del2))-
(abs(v2)*abs(v3)*abs(ybus(2,3))*cos((angle(ybus(2,3)))+del2-del3));
J(3,2)=(abs(v2)*abs(v3)*abs(ybus(2,3))*cos((angle(ybus(2,3)))+del2-del3));
J(3,3)=-(abs(v2)*abs(ybus(2,1))*sin((angle(ybus(2,1)))+del1-del2))-
2*(abs(v2)*abs(ybus(2,2))*sin((angle(ybus(2,2))))-
(abs(v3)*abs(ybus(2,3))*sin((angle(ybus(2,3)))+del3-del2)));
end
J
inv(J);
A=[del2;del3;abs(v2)];
delA0=[delp20;delp30;delq20];
delA1=inv(J)*delA0;
delA1;
b0=abs(v2);
A1=[del2;del3;b0]+delA1;
A1-delA0;
if((A1-delA0)<=t)
break;
del2=A1(1,1);
del3=A1(2,1);
abs(v2)=A1(3,1);
end
A1
OUTPUT:
t=
1.0000e-003
J=
24.4691 -12.2346 2.5881
-12.2346 24.9585 -3.0586
0 -3.0586 59.7611
A1 =
-0.0050
-0.0639
1.0292
RESULT
Thus the power flow for the given problem was solved using Newton Raphson method and
verified using MATLAB software.
LOAD – FREQUENCY DYNAMICS OF SINGLE AREA POWER SYSTEMS
Expt . No :
Date :
AIM :
To become familiar with modelling and analysis of the frequency and tie-line flow dynamics of a
power system without and with load frequency controllers (LFC) and to design better controllers for getting
better responses.
SOFTWARE REQUIRED : MATLAB 7.9
THEORY :
Active power control is one of the important control actions to be perform to be normal operation of
the system to match the system generation with the continuously changing system load in order to maintain
the constancy of system frequency to a fine tolerance level. This is one of the foremost requirements in
proving quality power supply. A change in system load cases a change in the speed of all rotating masses (
Turbine – generator rotor systems) of the system leading to change in system frequency. The speed change
form synchronous speed initiates the governor control (primary control) action result in all the participating
generator – turbine units taking up the change in load, stabilizing system frequency. Restoration of frequency
to nominal value requires secondary control action which adjust the load - reference set points of selected (
regulating) generator – turbine units. The primary objectives of automatic generation control (AGC) are to
regulate system frequency to the set nominal value and also to regulate the net interchange of each areas to the
scheduled value by adjusting the outputs of the regulating units. This function is referred to as load –
frequency co ntrol(LFC).
PROCEDURE :
1. Enter the command window of the MATLAB.
2. Create a new Model by selecting File - New – Model
3. Pick up the blocks from the simulink library browser and form a block diagram.
4. After forming the block diagram , save the block diagram.
5. Double click the scope and view the result.
PROGRAM:
clc;
pr=input('Enter the area capacity:');
pd=input('Enter the normal operating load:');
h=input('Enter the inertia constant:');
R=input('Enter the regulation:');
f=input('Enter operating frequency:');
m=input('Enter increase in load:');
D=pd/(f*pr);
kp=1/D
tp=(2*h)/(f*D)
disp('change in frequency:');
b=D+(1/R);
df=-(m/b);
g1=input('Enter the value of gen1:');
g2=input('Enter the value of gen2:');
l1=input('Enter the value of load1:');
l2=input('Enter the value of load2:');
sr1=input('Enter the spinning reverese of 2 areas:');
sr2=input('');
r1=input('Enter the regulation % of 2 areas:');
r2=input('');
m1=input('Enter the change in area of 2 load areas:');
m2=input('');
f=input('Enter the frequency:');
d1=input('Enter the % change in load:');
d2=input('');
R1=(r1/100)*(f/(g1+sr1))
R2=(r2/100)*(f/(g2+sr2))
D1=d1*((l1-m1)/f)
D2=d2*((l2-m2)/f)
b1=(D1+(1/R1))
b2=(D2+(1/R2))
df=(m1+m2)/(b1+b2)
disp('static frequency:');
x=f+df
pg1=(-df)/R1
pg2=(-df)/R2
pd1=D1*df
pd2=D2*df
gen1=g1+pg1;
gen2=g2+pg2;
load1=(l1-m1)+pd1;
load2=(l2-m2)+pd2;
disp('the tie line power1:');
tie1=gen1-load1
disp('the tie line power2:');
tie2=gen2-load2
OUTPUT:
Enter the area capacity:2000
Enter the normal operating load:1000
Enter the inertia constant:5
Enter the regulation:2.4
Enter operating frequency:60
Enter increase in load:0.01
kp = 120
tp = 20
change in frequency:
Enter the value of gen1:19000
Enter the value of gen2:41000
Enter the value of load1:20000
Enter the value of load2:40000
Enter the spinning reverese of 2 areas:1000
1000
Enter the regulation % of 2 areas:55
55
Enter the change in area of 2 load areas:10000
10000
Enter the frequency:60
Enter the % change in load:11
11
R1 = 0.0017
R2 = 7.8571e-004
D1 = 1.8333e+003
D2 = 5500
b1 = 2.4394e+003
b2 = 6.7727e+003
df = 2.1711
static frequency:
x = 62.1711
pg1 = -1.3158e+003
pg2 = -2.7632e+003
pd1 = 3.9803e+003
pd2 = 1.1941e+004
the tie line power1:
tie1 = 3.7039e+003
the tie line power2:
tie2 = -3.7039e+003
RESULT:
Thus analysis of the frequency and tie-line flow dynamics of a power system without and with load frequency
controllers (LFC) and verified using MATLAB software.
FAULT ANALYSIS
Expt.No :
Date :
AIM :
To become familiar with modelling and analysis of power systems under faulted condition and
to compute the fault level, post-fault voltages and currents for different types of faults, both
symmetric and unsymmetric.
THEORY :
Symmetrical Fault :
Unsymmetrical Fault :
Single line to ground fault :
Fault current If = Ia = 3Ia1
Ia1 = Ea
Z1+Z2+Z0
Ia1 =
Z1+Z2
Z0 + Z2
Ia2 = (- Ia1) * Z0
Z0 + Z2
where, Ia1, Ia2 and Ia0 are positive, negative and zero phase sequence currents
Z1 ,Z2 and Zo are positive, negative and zero phase sequence impedances
PROCEDURE:
PROGRAM :
clc;
xg=input('Enter the reactance of Generator in p.u:');
xt=input('Enter the reactance of transformer in p.u:');
xm=input('Enter the reactance of motor in p.u:');
vg=input('Enter the Terminal volage of Generator in p.u:');
i=input('Enter the output current of generator:');
pf=input('Enter the power factor:');
f=input('Enter which bus fault occur :');
disp('since fault occur in motor terminal');
disp('During fault reactance of gen & trans r series');
x=xg+xt;
x2=xm;
disp('x1 & x2 r parallel during fault');
Zth=(x*x2)/(x+x2);
disp('Equivalent impedence');
Zth
Eth=vg-i*xt;
Eth
If=Eth/Zth;
Ig=If*(x2/(x+x2));
Im=-If*(x/(x+x2));
disp('If');
abs(If)
x=angle(If);
y=x*180/3.14
disp('Ig');
abs(Ig)
a=angle(Ig);
b=a*180/3.14
disp('Im');
abs(Im)
c=angle(Im);
d=c*180/3.14
OUTPUT:
Enter the reactance of Generator in p.u:0.15i
Enter the reactance of transformer in p.u:0.1i
Enter the reactance of motor in p.u:0.35i
Enter the Terminal volage of Generator in p.u:0.9
Enter the output current of generator:0.8+0.6i
Enter the power factor:0.8
Enter which bus fault occur :2
since fault occur in motor terminal
During fault reactance of gen & trans r series
x1 & x2 r parallel during fault
Equivalent impedence
Zth =
0 + 0.1458i
Eth =
0.9600 - 0.0800i
If
ans =
6.6057
y=
-94.8117
Ig
ans =
3.8533
b=
-94.8117
Im
ans =
2.7524
d=
85.2796
MODEL CALCULATION:
RESULT
Thus analysis of power systems under faulted condition and to compute the fault level, post-fault
voltages and currents for different types of faults, both symmetric and unsymmetric.was studied and
simulated using MATLAB software.
TRANSIENT AND SMALL SIGNAL STABILITY ANALYSIS – SIN GLE MACHINE
INFINITE BUS SYSTEM
Expt.No :
Date :
AIM :
To become familiar with various aspects of the transient and small signal stability
analysis of Single-Machine-Infinite Bus (SMIB) system
PROGRAM REQUIRED : MATLAB 7.6
THEORY :
Stability : Stability problem is concerned with the behaviour of power system when it is
subjected to disturbance and is classified into small signal stability problem if the disturbances
are small and transient stability problem when the disturbances are large.
Transient stability: When a power system is under steady state, the load plus transmission loss
equals to the generation in the system. The generating units run a synchronous speed and system
frequency, voltage, current and power flows are steady. When a large disturbance such as three
phase fault, loss of load, loss of generation etc., occurs the power balance is upset and the
generating units rotors experience either acceleration or deceleration. The system may come back
to a steady state condition maintaining synchronism or it may break into subsystems or one or
more machines may pull out of synchronism. In the former case the system is said to be stable
and in the later case it is said to be unstable.
Small signal stability: When a power system is under steady state, normal operating condition,
the system may be subjected to small disturbances such as variation in load and generation,
change in field voltage, change in mechanical toque etc., The nature of system response to small
disturbance depends on the operating conditions, the transmission system strength, types of
controllers etc. Instability that may result from small disturbance may be of two forms,
(i) Steady increase in rotor angle due to lack of synchronising torque.
(ii) Rotor oscillations of increasing magnitude due to lack of sufficient damping torque.
FORMULA :
-1
Reactive power Qe = sin(cos (p.f))
S*
Stator Current It = *
Et
Pe - jQe
=
*
Et
Voltage behind
1 transient condition
1
E = Et + j X I
d t
Voltage of infinite bus
EB = Et - j( X3 + Xtr )It
X1 X2
where, X3 =
X1 + X2
1
Angular separation between E and EB
1
δo = ∠ E - ∠ EB
Prefault Operation:
X1 X2
1
X = j Xd + jXtr +
X1 + X2
1
E x EB
Power Pe = sinδo
X
e * X
-1
δo = sin
1
E * EB
Pe = PEii = 0
1
E x EB
Power Pe = sinδo
X
δmax = π - δo
Pm
Pe =
sinδmax
Critical Clearing Angle:
Pm(δδmax - δo ) + P3maxcosδδmax - P2maxcosδδo
Cosδcr =
P3max - P2max
Critical Clearing Time:
2H (δcr - δo)
tcr =
√ πfo Pm Sec
PROCEDURE :
1. Enter the command window of the MATLAB.
2. Create a new M – file by selecting File - New – M – File
3. Type and save the program.
4. Execute the program by either pressing Tools – Run
5. View the results.
EXERCISE :
1).Given the system of figure below where a 3phase fault is applied at point ‘p’ as shown.
DATAS:
PROGRAM :
% TRANSIENT AND SMALL SIGNAL STABILITY ANALYSIS – SIN GLE MACHINE INFINITE BUS
SYSTEM
clc;
el=input('Enter the generator voltage in p.u:');
v=input('Enter the volt of infinite bus:');
p=input('Enter the delivered by generator:');
x1=input('Enter the impedance between gen& feeder1:');
x2=input('Enter the parllel line1 impedance between feeder1&feeder2:');
x3=input('Enter the parllel line2 impedance between feeder1&feeder2:');
x4=input('Enter the impedance between feeder2&infinitebus:');
disp('1.Normal operation (pre fault):')
xn=(x1+((x2*x3)/(x2+x3))+x4);
del=(xn*p)/(el*v);
cn=asin(del);
disp('prefault operation angle is:');
cn
disp('2.during fault:');
fed=input('Enter the feeder where fault occurs:');
disp('No power is transfered during fault because of breaking of specified feeder');
disp('p2=0');
disp('3.post fault operation:');
disp('Fault occurs at parallel line x3');
xp=x1+x2+x4;
delp=(xp*p)/(v*el);
cp=asin(delp);
cpmax=(3.14-cp);
disp('the post clearing angle is:');
cpmax
pmax2=0;
pmax3=(v*el)/xp;
crit=((p*(cpmax-cn))-(pmax2*cos(cn))+(pmax3*cos(cpmax)))/(pmax3-pmax2);
crc=acos(crit);
disp('The clearing angle (radians):');
crc
crc=(180/3.14)*crc;
disp('The critical clearing angle is:');
crc
OUTPUT:
Enter the generator voltage in p.u:1.2
Enter the volt of infinite bus:1
Enter the delivered by generator:1
Enter the impedance between gen& feeder1:.25
Enter the parllel line1 impedance between feeder1&feeder2:.5
Enter the parllel line2 impedance between feeder1&feeder2:.4
Enter the impedance between feeder2&infinitebus:.05
1.Normal operation (pre fault):
prefault operation angle is:
cn =
0.4502
2. during fault:
Enter the feeder where fault occurs:2
No power is transfered during fault because of breaking of specified feeder
p2=0
3. post fault operation:
Fault occurs at parallel line x3
the post clearing angle is:
cpmax =
2.4103
The clearing angle (radians):
crc =
0.9735
The critical clearing angle is:
crc =
55.8069
MANUAL CALCULATION
RESULT
Transient and small signal stability analysis of Single-Machine-Infinite Bus (SMIB)
system was studied and simulated using MATLAB software.
ELECTROMAGNETIC TRANSIENTS IN POWER SYSTEMS
AIM:
To plot the electro magnetic transients in the power system using MATLAB
SOFTWARE REQUIRED:
MATLAB 6.1
FORMULA USED:
Case(i):
REACTIVE TERMINATION:LINE TERMINATED BY INDICATOR:
it(s ) = 2E f /L
s(s+Zc/L)
et(s) = 2Ef
(s+Zc/L)
it(s) = 2E (1-e –Zct/L)
Zc
ir = E (1-2e-Zct/L)
Zc
Case (ii):LINE TERMINATED BY CAPACITANCE:
it(s) = 2E (1/S+I/ZcC )
EE76 Power System Simulation Lab
Page 30 of 57
©Einstein College of Engineering
Zc
Case (iii):LINE TERMINATED BY A RESISTANCE EQUAL TO SURGE IMPEDANCE:
it(s) = 2E
ZcS
ef(s) = E
Case (iv):OPEN CIRCUITED LINE:
et = 2ef
er = ef
ir = - if
Case (v):SHORT CIRCUITED LINE:
it = 2if
er = -ef
ir = if
Where,
ef , if - forward voltage and current
et , it - transmitted voltage and current
er , ir - reflected voltage and current
PROCEDURE :
1. Enter the command window of the MATLAB.
2. Create a new M – file by selecting File - New – M – File
3. Type and save the program.
4. Execute the program by either pressing Tools – Run
5. View the results.
PROGRAM:
%line terminated by inductor for voltage
Ef=10000;
L=0.004;
Zc=400;
n1=[2*Ef 0];
d1=[1 Zc/L];
t=0:0.00001:0.0001;
Et=step(n1,d1,t);
plot(t,Et,'r');
Er=Et-Ef;
hold on;
plot(t,Er,'b');
OUTPUT RESPONSE:
OUTPUT RESPONSE:
%line terminated by inductor for current
Ef=10000;
L=0.004;
Zc=400;
n1=[2*Ef 0];
d1=[1 Zc/L];
tf(n1,d1)
t=0:0.00001:0.0001;
n2=[2*Ef/L];
d2=[1 Zc/L];
It=step(n2,d2,t);
plot(t,It,'r');
If=Ef/Zc;
Ir=It-If;
hold on;
plot(t,Ir,'b');
OUTPUT RESPONSE:
RESULT:
The electro magnetic transients in the power system was studied and simulated using
MATLAB software.
TRANSIENT STABILITY ANALYSIS – MULTI MACHINE INFINITE BUS SYSTEM
Expt.No :
Date :
AIM :
To become familiar with various aspects of the transient and small signal stability
analysis of Single-Machine-Infinite Bus (SMIB) system
PROGRAM REQUIRED : MATLAB 7.6
THEORY :
Stability : Stability problem is concerned with the behaviour of power system when it is
subjected to disturbance and is classified into small signal stability problem if the disturbances
are small and transient stability problem when the disturbances are large.
Transient stability: When a power system is under steady state, the load plus transmission loss
equals to the generation in the system. The generating units run a synchronous speed and system
frequency, voltage, current and power flows are steady. When a large disturbance such as three
phase fault, loss of load, loss of generation etc., occurs the power balance is upset and the
generating units rotors experience either acceleration or deceleration. The system may come back
to a steady state condition maintaining synchronism or it may break into subsystems or one or
more machines may pull out of synchronism. In the former case the system is said to be stable
and in the later case it is said to be unstable.
Small signal stability: When a power system is under steady state, normal operating condition,
the system may be subjected to small disturbances such as variation in load and generation,
change in field voltage, change in mechanical toque etc., The nature of system response to small
disturbance depends on the operating conditions, the transmission system strength, types of
controllers etc. Instability that may result from small disturbance may be of two forms,
(iii) Steady increase in rotor angle due to lack of synchronising torque.
(iv) Rotor oscillations of increasing magnitude due to lack of sufficient damping torque.
FORMULA :
-1
Reactive power Qe = sin(cos (p.f))
S*
Stator Current It =
*
Et
Pe - jQe
=
*
Et
Voltage behind
1 transient condition
1
E = Et + j X I
d t
Voltage of infinite bus
EB = Et - j( X3 + Xtr )It
X1 X2
where, X3 =
X1 + X2
1
Angular separation between E and EB
1
δo = ∠ E - ∠ EB
Prefault Operation:
X1 X2
1
X = j Xd + jXtr +
X1 + X2
1
E x EB
Power Pe = sinδo
X
e * X
-1
δo = sin
1
E * EB
During Fault Condition:
Pe = PEii = 0
1
E x EB
Power Pe = sinδo
X
δmax = π - δo
Pm
Pe =
sinδmax
Critical Clearing Angle:
Pm(δδmax - δo ) + P3maxcosδδmax - P2maxcosδδo
Cosδcr =
P3max - P2max
Critical Clearing Time:
2H (δcr - δo)
tcr =
√ πfo Pm Sec
PROCEDURE :
1. Enter the command window of the MATLAB.
2. Create a new M – file by selecting File - New – M – File
3. Type and save the program.
4. Execute the program by either pressing Tools – Run
5. View the results.
EXERCISE :
1).Given the system of figure below where a 3phase fault is applied at point ‘p’ as shown.
DATAS:
PROGRAM :
% TRANSIENT AND SMALL SIGNAL STABILITY ANALYSIS –MULTI MACHINE INFINITE BUS
SYSTEM
clc;
el=input('Enter the generator voltage in p.u:');
v=input('Enter the volt of infinite bus:');
p=input('Enter the delivered by generator1:');
x1=input('Enter the impedance between gen& feeder1:');
x2=input('Enter the parllel line1 impedance between feeder1&feeder2:');
x3=input('Enter the parllel line2 impedance between feeder1&feeder2:');
x4=input('Enter the impedance between feeder2&generator2:');
disp('1.Normal operation (pre fault):')
xn=(x1+((x2*x3)/(x2+x3))+x4);
del=(xn*p)/(el*v);
cn=asin(del);
disp('prefault operation angle is:');
cn
disp('2.during fault:');
fed=input('Enter the feeder where fault occurs:');
disp('No power is transfered during fault because of breaking of specified
feeder');
disp('p2=0');
disp('3.post fault operation:');
disp('Fault occurs at parallel line x3');
xp=x1+x2+x4;
delp=(xp*p)/(v*el);
cp=asin(delp);
cpmax=(3.14-cp);
disp('the post clearing angle is:');
cpmax
pmax2=0;
pmax3=(v*el)/xp;
crit=((p*(cpmax-cn))-(pmax2*cos(cn))+(pmax3*cos(cpmax)))/(pmax3-pmax2);
crc=acos(crit);
disp('The clearing angle (radians):');
crc
crc=(180/3.14)*crc;
disp('The critical clearing angle is:');
crc
OUTPUT:
Enter the generator voltage in p.u:1.2
Enter the volt of infinite bus:1
Enter the delivered by generator1:1
Enter the impedance between gen& feeder1:.25
Enter the parllel line1 impedance between feeder1&feeder2:.5
Enter the parllel line2 impedance between feeder1&feeder2:.4
Enter the impedance between feeder2&generator2:.05
1.Normal operation (pre fault):
prefault operation angle is:
cn =
0.4502
2. during fault:
Enter the feeder where fault occurs:2
No power is transfered during fault because of breaking of specified feeder
p2=0
3. post fault operation:
Fault occurs at parallel line x3
the post clearing angle is:
cpmax =
2.4103
The clearing angle (radians):
crc =
0.9735
The critical clearing angle is:
crc =
55.8069
MANUAL CALCULATION
RESULT
Transient and small signal stability analysis of Single-Machine-Infinite Bus (SMIB)
system was studied and simulated using MATLAB software.
ECONOMIC DISPATCH IN POWER SYSTEMS
Expt.No :
Date :
AIM :
To understand the fundamentals of economic dispatch and solve the problem
using classical method with and without line losses.
PROGRAM REQUIRED : MATLAB 5.3
THEORY :
In a power system, with negligible transmission loss and with N number of spinning thermal
generating units the total system load PD at a particular interval can be met by different sets of
generation schedules
(k) (k) (K)
{PG1 , PG2 , ………………PG N }; k = 1,2, ...........NS
Out of these NS set of generation schedules, the system operator has to choose the set of schedules,
which minimize the system operating cost, which is essentially the sum of the production cost of
all the generating units. This economic dispatch problem is mathematically stated as an
optimization problem.
Given : The number of available generating units N, their production cost functions,
their operating limits and the system load PD,
2
Fi (PGi) = ai PG i + bi PGi + ci ; i = 1,2,…….N ( 5)
where ai , bi and ci are constants
The ED problem given by the equations (1) to (4). By omitting the inequality constraints
(4) tentatively, the reduce ED problem (1),(2) and (3) may be restated as an unconstrained
optimization problem by augmenting the objective function (1) with the constraint φ multiplied
by LaGrange multiplier, λ to obtained the LaGrange function, L as
N N
Min : L (PG1 ……..PG N , λ) = Σ Fi(PGi) - λ [Σ PGi – PD] ( 6)
i=1 i=1
The necessary conditions for the existence of solution to (6) are given by
(
∂L / ∂PGi = 0 = dFi (PGi) / dPGi - λ ; i = 1, 2,……..N 7)
N
∂L / ∂λ = 0 = Σ PGi – PD (8)
i=1
The solution to ED problem can be obtained by solving simultaneously the necessary conditions
(7) and (8) which state that the economic generation schedules not only satisfy the system power
balance equation (8) but also demand that the incremental cost rates of all the units be equal be
equal to λ which can be interpreted as “incremental cost of received power”.
When the inequality constraints(4) are included in the ED problem the necessary condition (7)
gets modified as
N N
λ= PD + Σ( bi/2ai / Σ (1/2ai) (11)
i=1 i=1
PROCEDURE :
1. Enter the command window of the MATLAB.
2. Create a new M – file by selecting File - New – M – File
3. Type and save the program.
4. Execute the program by either pressing Tools – Run.
5. View the results.
EXERCISE :
1.The fuel cost functions for three thermal plants in $/h are given by
2
C1 = 500 + 5.3 P1 + 0.004 P1 ; P1 in MW
2
C2 = 400 + 5.5 P2 + 0.006 P2 ; P2 in MW
2
C3 = 200 +5.8 P3 + 0.009 P3
; P3 in MW
The total load , PD is 800MW.Neglecting line losses and generator limits, find the optimal
dispatch and the total cost in $/h by analytical method. Verify the result using MATLAB
program.
PROGRAM :
alpha = [500; 400; 200];
beta = [5.3; 5.5; 5.8]; gamma = [0.004; 0.006; 0.009];
PD = 800;
DelP = 10;
lamda = input('Enter estimated value of Lamda = ');
fprintf(' ')
disp(['Lamda P1 P2 P3 DP'...
' grad Delamda'])
iter = 0;
while abs(DelP) >= 0.001
iter = iter + 1;
P = (lamda - beta)./(2*gamma);
DelP = PD - sum(P);
J = sum(ones(length(gamma),1)./(2*gamma));
Delamda = DelP/J;
disp([lamda,P(1),P(2),P(3),DelP,J,Delamda])
lamda = lamda + Delamda;
end
totalcost = sum(alpha + beta.*P + gamma.*P.^2)
OUTPUT:
Enter estimated value of Lamda = 12
Lamda P1 P2 P3 DP grad Delamda
Columns 1 through 2
12.0000 837.5000
Columns 3 through 4
541.6667 344.4444
Columns 5 through 6
-923.6111 263.8889
Column 7
-3.5000
Columns 1 through 2
8.5000 400.0000
Columns 3 through 4
250.0000 150.0000
Columns 5 through 6
0 263.8889
Column 7
0
totalcost =
6.6825e+003
MANUAL CALCULATION:
RESULT:
Economic load dispatch for the given problem was solved using classical method with and
without line losses and verified using MATLAB software.
VIVA QUESTIONS:
1. What are the components of power system?
2. Define per unit value.
3. What is the need for base values?
4. What are the advantages of per unit computations?
5. What is impedance & reactance?
6. What is a bus?
7. Name the diagonal & off diagonal elements of bus admittance matrix?
8. What is bus admittance matrix?
9. What is bus impedance matrix?
10. What are the methods available for forming bus admittance matrix?
11. Write the symmetrical components of 3 phase system?
12. What is meant by positive negative & zero sequence impedance?
13. What is power flow study or load flow study?
14. What is the need for load flow study?
15. What are the different types of buses in a power system?
16. What are the information that are obtained from a load flow study?
17. What is swing bus?
18. What is the need for slag bus?
19. What do you mean by a flat voltage start?
20. When the generator buses treated as load bus?
21. What is jacobian matrix?
22. What is infinite bus?
23. How the reactive power of generator is controlled?
24. How the faults are classified?
25. List the symmetrical & unsymmetrical faults?
26. What is the need for short circuit studies?
27. Define transient & sub transient reactance.
28. Name the various unsymmetrical faults in a power system.
29. Define stability.
30. Define steady state & transient stability.
31. Explain steady state stability limit
32. Explain transient stability limit.
33. How stability studies are classified. What are they?
34. Define swing curve.
35. Define power angle.
36. Define equal area criterion.
37. What is AGC?
38. Explain unit commitment.
39. What is economic dispatch?
40. Explain participation factor.