PS5111-Power System Simulation Lab-I
PS5111-Power System Simulation Lab-I
ACADEMIC YEAR:2018-2019
1
PS5111-Power System Simulation Laboratory
SYLLABUS
3. Contingency analysis: Generator shift factors and line outage distribution factors
6. State Estimation
11. Co-ordination of over-current and distance relays for radial line protection
2
PS5111-Power System Simulation Laboratory
CYCLE - I
1. Power flow analysis by Newton-Raphson method
2. Power flow analysis by Fast decoupled method
3. Transient stability analysis of single machine-infinite bus system using classical
machine model
4. Economic dispatch using lambda-iteration method
5. Contingency analysis: Generator shift factors and line outage distribution factors
6. Unit commitment: Priority-list schemes and dynamic programming
CYCLE - II
7. State Estimation
8. Analysis of switching surge using EMTP: Energisation of a long distributed-
parameter line
9. Analysis of switching surge using EMTP: Computation of transient recovery
voltage
10. Simulation and Implementation of Voltage source Inverter
11. Digital and over current relay setting and relay coordination
12. Co-ordination of over current and distance relay for radial line protection
ADDITIONAL EXPERIMENTS
13. Transient behaviour of Three-Phase Induction Machine during Starting
14. Small signal stability analysis of a single machine infinite bus system with field
circuit, exciter and power system stabilizer
3
PS5111-Power System Simulation Laboratory
INDEX
Date of Name of the experiment Date of Staff Sign
S.No Experiment. submission.
1.
2.
3.
4.
5.
6.
7.
8.
9.
10.
11.
12.
4
PS5111-Power System Simulation Laboratory
Exp.No: 1
Date:
POWER FLOW ANALYSIS BY NEWTON-RAPHSON METHOD
Aim:
To develop Newton-Raphson (N-R) method for solving power flow equations. To
develop the expressions for the elements of Jacobian matrix. To demonstrate the iterative
process of N-R method using the given test system and to check the results with the
available load flow programs using MATLAB software.
Development of N-R Method:
Modeling Assumption
Bus generation and demands are modeled by complex power injections.
Lines and transformers are modeled by PI equivalent circuit.
Shunt compensators by shunt susceptance.
At the kth bus the real and reactive power injections are given by
where (2)
where (3)
Where
where (4)
where (5)
The above equations can be compactly represented as
(6)
where (7)
Compact power flow equation has to be solved using N-R method to obtain the state
vector through iterative process. Once the solution is obtained the unknown real and
reactive injections and power flow in each line can be computed.
N-R algorithm
To solve
Let be the assumed solution.
Let be small and be the deviation from the correct solution then
(8)
Expanding vector function F by the taylor series around and truncating second and
higher order terms we get
=0 (9)
where is the iteration number
The above equation can be rearranged as
(10)
Substituting the value for from equations (2) and (3)
(11)
Where
is the jacobian matrix , is the state correction matrix and is the
mismatch vector
The equation (12) can be detailed expressed as
6
PS5111-Power System Simulation Laboratory
(13)
Elements of Jacobian
In order to make to computations of Jacobian elements more efficient the
equations are modified as shown
(14)
Let , , and
The matrix and can be expressed in terms of and
The off diagonal elements of the above matrices are given by the equations (15) to (18)
(15)
(16)
(17)
(18)
The diagonal elements of the matrices are given by the equations (19) to (22)
(19)
(20)
(21)
(22)
The jacobian elements are functions of latest state vector and bus admittance matrix. The
jacobian matrix is real and has symmetric sparse structure, but asymmetric in value.
7
PS5111-Power System Simulation Laboratory
Flowchart
Read Data: , , k=1,2 …N
k=1,2,…NP
, , where , tolerance
Yes
Is
No
Print Solution
Set
8
PS5111-Power System Simulation Laboratory
Compute
Set
Do
Yes
Is
No
Yes
Is
No
Switch bus k to P-Q bus
Switch bus k to P-Q bus Is bus k is at P-Q bus status switch
back to P-V bus status change Change
Change
Set
9
PS5111-Power System Simulation Laboratory
Exercise:
Consider 3 bus system each has a line of a series impedance of 0.02+j0.02p.u and total
shunt admittance of j0.02pu.The specified capacity of buses are tabulated below
Controllable reactive power souce is available at bus 3 with a constraint 0≤QG≤1.5.Find
the total flow solution using NR method with power flow mismatch
Bus Real Load Reactive Real power Reactive Voltage
No Demand( PD ) load generation power Gen. specification
demand (PG) (QG)
(QD)
1 2.0 1.0 - - 1.0+j0
2 0 0 0.5 1.0 -
3 1.5 0.6 0.0 QG3? 1.04
PROGRAM
clc;
clear;
%line From to R+jX
ldata=[1 1 2 0.02+0.04i
2 1 3 0.01+0.03i
3 2 3 0.0125+0.025i];
%bus V d P Q Type
bdata=[1 1.05 0 0 0 0
2 1.00 0 -4 -2.5 2
3 1.04 0 2 0 1];
nbus=length(bdata(:,1));
nlines=length(ldata(:,1));
V=bdata(:,2);
d=bdata(:,3);
P=bdata(:,4);
Q=bdata(:,5);
type=bdata(:,6);
y=zeros(nbus);
for j=1:nlines;
l=ldata(j,2);
m=ldata(j,3);
y(l,l)=y(l,l)+(1/ldata(j,4))+ldata(j,5);
y(m,m)=y(m,m)+(1/ldata(j,4))+ldata(j,5);
y(l,m)=-(l/ldata(j,4));
y(m,l)=y(l,m);
end
Y=abs(y);
t=angle(y);
poweracc=10^-6;
DC=1;
iter=0;
while poweracc<max(abs(DC));
10
PS5111-Power System Simulation Laboratory
iter=iter+1;
disp('ITERATION');
disp(iter);
v=V.*(exp(complex(0,d)));
Pcal=real((v).*conj(y*v));
Qcal=imag((v).*conj(y*v));
DelP=P-Pcal;
DelQ=Q-Qcal;
DX=[DelP;DelQ];
for j=(1:nbus);
for k=(1:nbus);
J1(k,j)=-imag(conj(v(k))*v(j)*y(k,j));
J2(k,j)=real(conj(v(k))*v(j)*y(k,j))/V(j);
J3(k,j)=-real(conj(v(k))*v(j)*y(k,j));
J4(k,j)=-imag(conj(v(k))*v(j)*y(k,j))/V(j);
end
end;
for k=(1:nbus);
J1(k,k)=-Qcal(k)-imag(V(k)^2*y(k,k));
J2(k,k)=(Pcal(k)/V(k))+real(V(k)*y(k,k));
J3(k,k)=Pcal(k)-real(V(k)^2*y(k,k));
J4(k,k)=(Qcal(k)/V(k))-imag(V(k)*y(k,k));
end;
J=[J1 J2;
J3 J4];
K=[find(type==0);
find(type==0)+nbus;
find(type==1)+nbus];
DX(K)=[];
J(K,:)=[];
J(:,K)=[];
DC=J\DX;
d(2)=d(2)+(DC(1));
d(3)=d(3)+(DC(2));
V(2)=V(2)+(DC(3));
V,d
end;
i=1:nbus;
S(i)=v.*conj(y*v);
for a=1:nbus;
b=1:nbus;
LineCurrent(a,b)=-y(a,b)*(v(a)-v(b));
end;
for m=1:nbus;
for n=1:nbus;
PowerFlow(m,n)=v(m)*conj(LineCurrent(m,n));
end;
end;
11
PS5111-Power System Simulation Laboratory
for i=1:nbus;
for j=1:nbus;
Loss(i,j)=PowerFlow(i,j)+PowerFlow(j,i);
end;
end;
S,LineCurrent,PowerFlow,Loss
OUTPUT
Result:
Load flow for the given test system is carried out by Newton Raphson method and
the results have been verified by the MATLAB programs.
Viva Questions:
1. What is the need for load flow?
12
PS5111-Power System Simulation Laboratory
Exp.No:2 Date:
(1)
(2)
(3)
Where
(4)
(5)
(6)
(7)
and where
(8)
Assumptions:
Physically justifiable assumptions can be made which are always valid
is very small and hence and
Invoking the following in (7) and (8)
(9)
(10)
Assuming all values of to be equal to and comparing the value of
with it is found and hence
(11)
13
PS5111-Power System Simulation Laboratory
FDPF Method
Neglect the angle shifting effects of phase shifter in in (13). With all the above
modification the FDPF scheme becomes
(14)
(15)
and are real, sparse, symmetric constant matrix. They are computed and
factorized only once at the beginning of iterations and are not recomputed and
refactorized
Flowchart: Flowchart for the decoupled power flow is given below
14
PS5111-Power System Simulation Laboratory
Is Yes
No
No Yes
Is Yes
No
No Yes
B
A Converged. Compute
PV bus adjustment and Print solution
Stop
15
PS5111-Power System Simulation Laboratory
Compute
Set
Do
Yes
Is
No
No Yes
Is
Set
No
IS PV bus completed?
Yes
B
bus does not find a place in Augment with a new row and column
corresponding to P-V bus, say the bus and the sensitivity is found as shown
(16)
(17)
16
PS5111-Power System Simulation Laboratory
Exercise
For the two bus test system perform two iterations of N-R method using flat start and
obtain . Using this solution determine the real and reactive power mismatches at bus
2. Compute the line flow (MW, Mvar) and line losses. Compute slack bus generation.
Verify your results with available MATLAB programs.
.
V1=1.02 p.u.
0.02+j0.06 p.u
50 MW + j30Mvar
150 MW + j90Mvar
EXTRA PROBLEMS
Carry out a FDPF method for same two bus system with different specifications
given below
PROGRAM
clc;
clear all;
%Line From To R+jX Adm
ldata=[1 1 2 0.0+0.025i 0.0i
2 1 3 0.0+0.025i 0.0i
3 2 3 0.0+0.05i 0.0i];
%Bus V d P Q Type
bdata=[1 1.025 0 0 0 0
2 1.00 0 -4 -2 2
3 1.03 0 3 0 1];
nbus=length(bdata(:,1));nlines=length(ldata(:,1));
V=bdata(:,2);d=bdata(:,3);
type=bdata(:,6);P=bdata(:,4);Q=bdata(:,5);
y=zeros(nbus);
for j=1:nlines;
l=ldata(j,2);
m=ldata(j,3);
y(l,l)=y(l,l)+(1/ldata(j,4))+ldata(j,5);
y(m,m)=y(m,m)+(1/ldata(j,4))+ldata(j,5);
y(l,m)=-(1/ldata(j,4));y(m,1)=y(l,m);
end
17
PS5111-Power System Simulation Laboratory
BPr=imag(y);BPr(1,:)=[];BPr(:,1)=[];
INVBPr=inv(BPr);
BDPr=imag(y);K=[find(type==0);find(type==0)];
BDPr(K,:)=[];BDPr(:,K)=[];
INVBDPr=inv(BDPr);
Poweracc=0.0000025;
Deld=10;iter=0;
while Poweracc<abs(Deld);
iter=iter+1;
disp('iteration:');
disp(iter);
v=V.*(exp(complex(0,d)));
Pcal=real((v).*conj(y*v));
Qcal=imag((v).*conj(y*v));
DP=P-Pcal;DelP=DP;DelP(1)=[];
DQ=Q-Qcal;DelQ=DQ;DelQ(K)=[];
Deld=-INVBPr*DelP;DelV=-INVBDPr*DelQ;
d(2)=d(2)+(Deld(1)*V(2));d(3)=d(3)+(Deld(2)*V(3));
V(2)=V(2)+(DelV(1)*V(2));
iter,V,d
end;
i=1:nbus;
S(i)=v.*conj(y*v);
P(i)=real(S(i));Q(i)=imag(S(i));
for a=1:nbus;
for b=1:nbus;
Linecurrent(a,b)=-y(a,b)*(v(a)-v(b));
PowerFlow(a,b)=v(a)*conj(Linecurrent(a,b));
end;
end;
for i=1:nbus;
for j=1:nbus;
Loss(i,j)=PowerFlow(i,j)+PowerFlow(j,i);
end;
end;
V,d,S,PowerFlow,Linecurrent,Loss
OUTPUT
Piter Qiter
0 0 1 0.0 0.65 -
1 0 1 -2.2345 - 0.480400
1 1 0.9679 - 0.075759 -
2 1 - -1.965 - 0.006451
2 2 0.9675 - 0.008923 0.012617
18
PS5111-Power System Simulation Laboratory
Result: FDPF for the given test system is carried out ant the results have been
verified by using MATLAB programs
Viva questions:
1. What is PQ decoupling?
19
PS5111-Power System Simulation Laboratory
Expt. No:3
Date:
TRANSIENT STABILITY ANALYSIS OF SINGLE MACHINE-INFINITE BUS
SYSTEM USING CLASSICAL MACHINE MODEL
AIM:
To carry out transient stability analysis of an interconnected power system and
obtain the swing curves.
THEORY:
Transient stability of a power system is the ability of the system to maintain
synchronism among the generators when it is subjected to sudden, large transient
disturbance. The transient disturbance may be,
1. Sudden fault or short - circuit followed by opening of breakers
2. Sudden application or rejection of large load or sudden tripping of generators.
3. Switching operations
If the individual machine in a multi - machine power system are operating in steady - state
equilibrium and a disturbance of the kind mentioned above is imposed on the system, then
the system is said to be stable, if each machine oscillates around and ultimately settles to a
new equilibrium condition. This equilibrium condition is characterized by constant speed
of the machine.
Transient stability analysis is one of the essential simulation studies conducted by power
system engineers. The purpose of this is to find out the dynamic behaviour of the system
following a transient disturbance such as a fault on a high voltage line.
Critical clearing time has to be determined by conducting this study. This time is defined
as the maximum permissible fault clearing time for the system to remain stable under the
given conditions of disturbances. This involves the computation of swing curves by
solving the non - linear swing equation of the system using suitable numerical method.
Swing equation of multi - machine power system is,
H i1 d 2 d
1 1
D P P
f dt 2
i mi ai
dt
H i * MVA rating of i th generator
Hi
Base MVA for the given system
t = time in seconds.
20
PS5111-Power System Simulation Laboratory
In the above expressions, i vary from 1 to g, where g is the total number of synchronous
machines in the system.
Runge - Kutta Algorithm for Computation of Swing Curves:
Runge - Kutta method of fourth order is one of the best numerical method's used for the
purpose of solving the swing equation. The damping of the rotors must also be taken into
account to get the results in an accurate form.
According to this algorithm, the total transient period is typically of the order of one
second is divided into a large number of small intervals, each of t second duration.
During each t duration, the value of parameters K1, K2, K3, K4, and l1, l2, l3, l4, are
calculated. Thus, these parameters are used to determine the changes in I , i.
I( 0 ) = value of of the ith machine at the end of previous interval t .
f = nominal system frequency.
i = number of the machine.
f
I i 10 ( Pmi1 Pei1 (0) Di i )t
1
where,
Hi
HI' = per - unit inertia constant of the ith machine referred t the system base.
Pmi' = per - unit mechanical power of the ith generator.
Pei' = per - unit electrical power supplied by the ith generator.
i' (i (0) 2f 0 ) / 2f 0 = per - unit disturbance velocity of the ith machine
K 2i i (0) I i / 2 2f 0 ]t
I 2i 0
f
H i mi
' ' '
P Pei (0) D I ( I I I / 2 2f 0 t
Where,
Pei' ( 0 ) = electrical power of the ith generator calculated using i at the end of previous
t.
K 3i i (0) I 2 I / 2 2f 0 ]t
I 2i 0
f
H i mi
' '' '
P Pei (0) D I ( I I I / 2 2f 0 t
Where,
Pei'' (0) = electrical power of the ith generator calculated by using i ( 0 ) + K2 / 2
K 4i i (0) I 3I 2f 0 ]t
f
I 4i 0 ' Pmi Pei (0) DI ( I I 3I / 2 2f 0 t
Hi
' '' '
Where,
Pei'' ( 0 ) = electrical power of the ith generator calculated by using i ( 0 ) + K3
i ( new ) = i ( 0 ) + 1/ 6 * ( Ki + 2K2I + 2K3i + K4i )
I( new ) = I( 0 ) + 1/ 6 * ( li + 2l2i + 2l3i + l4i )
ALGORITHM:
1. Read inertia constant, machine transient reactance, tie - line reactance, voltages at
generator buses, bus powers, system frequency, type of fault.
2. Conduct load flow analysis.
3. Calculate the machine currents.
4. Calculate the voltage behind transient reactance E' is given by
E' = Vt + j It Xd
5. Assume mechanical powers are constant since governor action is not taken into
consideration.
21
PS5111-Power System Simulation Laboratory
6. The angle for E' is taken as initial value of and initial value of = 2fo .
7. Compute reduced YBUS for faulted and post faulted systems.
8. Calculate first estimates of phase angle K1 and speed l1
d
k1 | 0t i (0) 2f 0 t ----------- (1)
dt
d
I1 | 0t f 0 / H ( Pm Pe (0)) t ----------- (2)
'
dt
9. To calculate second estimate K2 and l2
K 2 ( (0) I 1 / 2) 2f 0 t ----------- (3)
I 2 f 0 / H Pm Pe1 (0) t ----------- (4)
10. To calculate third estimate K3 and l3
K 3 ( (0) I 2 / 2) 2f 0 t ----------- (5)
I 3 f 0 / H Pm Pe" (0) t ----------- (6)
11. To calculate fourth estimate K4 and l4
K 4 ( (0) I 3 / 2) 2f 0 t ----------- (7)
I 4 f 0 / H Pm Pe" (0) t ----------- (8)
12. Find the phase angle and speed at the end of the first interval
( t ) = ( t - 1 ) + 1/ 6 ( K1 + 2K2 + 2K3 + K4 ) ----------- ( 9 )
( t ) = ( t -1 ) + 1/ 6 ( l1 + 2l2 + 2l3 + l4 ) ----------- ( 10 )
13. Repeat from step (8) and calculate the phase angle and speed during the subsequent
time interval till t = 0.3seconds. All these calculations should be done using reduced Y BUS
matrix corresponding to faulted system.
14. Repeat the steps (8) to (12) for t =0.3seconds upto t = 1.0seconds by using reduced
YBUS matrix corresponding to faulted system.
15. Plot the swing curves and state the system is stable or not.
22
PS5111-Power System Simulation Laboratory
START
t=0.01
NO
t=t+ IS t|< tC
YES
STOP
23
PS5111-Power System Simulation Laboratory
PROBLEM STATEMENT
1) A 60 Hz Synchronous generator having inertia constant H= 5MJ/MVA and a direct
axis transient reactance Xd"= 0.3pu is connected to an infinite bus through a purely
resistive circuit. Reactance’s are marked on the diagram with a common base .The
generator is delivering real power Pe = 0.8pu and Q = 0.074pu to infinite bus at a voltage
of 1 pu.
(a) A temporary 3 phase fault occurs at sending end of the line at point F When the fault is
cleared both lines are intact. Determine the critical clearing angle and fault clearing time.
(b) A 3 phase fault occurs at middle of one line the fault is cleared and the faulted line is
isolated Determine the critical Clearing angle.
(c) The fault is cleared at 0.3 sec .Obtain the numerical solution of swing equation for 1
sec using modified Euler's method with step size d(t) = 0.01 sec. Obtain simulink model
for swing equation and simulate for Tc of 0.3 & 0.5 sec.
24
PS5111-Power System Simulation Laboratory
PROGRAM
clc;
clear;
h=0.005;
del0=21.64*pi/180;
omega0=1;
ti=0;
tf=0.5;
n=round((tf-ti)/h);
t(1)=ti;
del(1)=del0;
omega(1)=omega0;
tc=0.15;
for i=1:n
if(t(i)==ti)
status=0;
end
if(t(i)==tc)
status=1;
end
if (t(i)>ti && t(i)<tc)
status=2;
end
if (t(i)>tc)
status=3'
end
l1=h*swing(del(i),omega(i),status);
k1=h*omega(i);
l2=h*swing(del(i)+0.5*k1,omega(i)+0.5*l1,status); %R-K algorithm
k2=h*(omega(i)+0.5*l1);
l3=h*swing(del(i)+0.5*k2,omega(i)+0.5*l2,status);
k3=h*(omega(i)+0.5*l2);
l4=h*swing(del(i)+k3,omega(i)+l3,status);
k4=h*(omega(i)+l3);
k=(k1+2*(k2+k3)+k4)/6;
l=(l1+2*(l2+l3)+l4)/6;
omega(i+1)=omega(i)+1;
del(i+1)=del(i)+k;
t(i+1)=t(i)+h;
end
plot(t,del*180/pi);
grid on;
xlable('time----->');
ylable('del(degrees)------->');
title('Plot of del various time');
swing
swing(del,omega,status)
[diffomega]=swing(del,omega,status)
M=2.52/(pi*50);
Pm=0.9;
25
PS5111-Power System Simulation Laboratory
Pmaxbf=2.44;
Pmaxdf=0.88;
Pmaxaf=2.00;
switch status
case 0
diffomega=((Pm-Pmaxbf*sin(del))+(Pm-Pmaxdf*sin(del)))/(2*M);
case 1
diffomega=((Pm-Pmaxdf*sin(del))+(Pm-Pmaxaf*sin(del)))/(2*M);
case 2
diffomega=(Pm-Pmaxdf*sin(del))/M;
case 3
diffomega=(Pm-Pmaxaf*sin(del))/M;
end
OUTPUT
enter the reactance between bus 1 and 20.6
enter the reactance between bus 2 and 30.4
enter the reactance between bus 1 and 30.8
enter the generated power40
enter the power demand130
enter the base100
xo =
0.4444 0.1778
0.1778 0.3111
del =
-0.0533
-0.3333
p =
0 0.4667 -0.0667
-0.4667 0 -0.8333
0.0667 0.8333 0
a =
0 0.4444 0.5556
-0.4444 0 0.4444
-0.5556 -0.4444 0
L12 = 1.0000
L23 = 1.0000
26
PS5111-Power System Simulation Laboratory
L13 = 1.0000
L23 = 0.5000
L12 = 1.0000
L13 = 1.0000
P12 = 0.2889
P13 = -0.2889
P23 = -1.0111
po =
0
-1.3000
xo =
0.4444 0.1778
0.1778 0.3111
del =
-0.2311
-0.4044
limp =
p12 = 0.2889
P13 = -0.2889
P23 = -1.0111
RESULT:
The Transient stability analysis has been carried out and simulated on a given power
system network.
VIVA Questions
1. What is the need of transient stability analysis?
2. Specify the value of power angle for the power system to remain in stability?
3. Define Synchronous coefficient.
4. Define steady state stability/
5. Define critical clearing angle and time
27
PS5111-Power System Simulation Laboratory
ALGORITHM:
STEP1: Start the program.
STEP2: Get the various values of line reactance, generated power, power demand,
base MVA values.
STEP3: Calculate the B coefficient matrix.
STEP4: Determine the line flows for the three bus system.
STEP5: Calculate the generation shift factors using
Ali =
Ll,k =
STEP7: Calculate the new line flows after the various generation outages as
Pnm = Pnm(old)+ ali * p
STEP8: Conduct the DC load flow to check the generation values match the
calculated line flows.
Problem:
Calculate the generation shift factors, line outages, generator outages for the given circuit
diagram. Take base MVA as 100.
28
PS5111-Power System Simulation Laboratory
RESULT:
Thus the program to perform contingency analysis of the given 3- bus system and to
calculate the distribution factors for various line outages was completed.
Viva Questions:
1. What is the need for contingency analysis?
29
PS5111-Power System Simulation Laboratory
PROGRAM
clear all;
clc;
r1=input('enter the reactance between bus 1 and 2');
r2=input('enter the reactance between bus 2 and 3');
r3=input('enter the reactance between bus 1 and 3');
limp=[(r1+r3) r1 r3;r1 (r1+r2) r2;r3 r2 (r3+r2)];
pg=input('enter the generated power');
pd=input('enter the power demand');
b=input('enter the base');
bo=[(1/r1)+(1/r3) -(1/r1);-(1/r1) (1/r1)+(1/r2)];
bo;
xo=inv(bo)
p=[(pg/b) -(pd/b)];
po=transpose(p);
del=(xo*po)
%line flows
del(3)=0;
p=[0 0 0;0 0 0;0 0 0];
for i=1:3
for j=1:3
if(i~=j)
p(i,j)=(del(i)-del(j))/limp(i,j);
end
end
end
p
%generation shift factors
a=[0 0 0;0 0 0;0 0 0];
xo(3)=0;
for i=1:3
for j=1:3
if(i~=j)
a(i,j)=(xo(i)-xo(j))/limp(i,j);
end
end
end
a
xo=inv(bo)
r1
r2
r3
L12=(xo(1,1)-xo(2,1))*r3/((r3-xo(1,1))*r1)
30
PS5111-Power System Simulation Laboratory
L23=(xo(2,1)*r3)/((r3-xo(1,1))*r2)
%outage of line 1-2
L13=(xo(1,1)-xo(1,2))*r1/((r1-((xo(1,1)-xo(1,2))-(xo(2,1)-xo(2,2))))*r3)
L23=-(xo(2,1)-xo(2,2))*r1/((r1-((xo(1,1)-xo(1,2))-(xo(2,1)-xo(2,2))))*r3)
%Outage of line 2-3
L12=(-(xo(1,2)-xo(2,2))*r2)/((r2-xo(2,2))*r1)
L13=(xo(1,2)*r2)/((r2-xo(2,2))*r3)
%The new line flows after outage of generator 1'
delp=-.4;
P12=p(1,2)+a(1,2)*delp
P13=p(1,3)+a(1,3)*delp
P23=p(2,3)+a(2,3)*delp
%'dc load flow'
po=[0;-1.3]
xo
del=xo*po
limp
p12=(del(1,1)-del(2,1))/limp(1,2)
P13=del(1,1)/limp(1,3)
P23=del(2,1)/limp(2,3)
31
PS5111-Power System Simulation Laboratory
OUTPUT
enter the reactance between bus 1 and 20.6
enter the reactance between bus 2 and 30.4
enter the reactance between bus 1 and 30.8
enter the generated power40
enter the power demand130
enter the base100
xo =
0.4444 0.1778
0.1778 0.3111
del =
-0.0533
-0.3333
p=
0 0.4667 -0.0667
-0.4667 0 -0.8333
0.0667 0.8333 0
a=
0 0.4444 0.5556
-0.4444 0 0.4444
-0.5556 -0.4444 0
xo =
0.4444 0.1778
0.1778 0.3111
r1 = 0.6000
r2 = 0.4000
r3 = 0.8000
L12 = 1.0000
L23 = 1.0000
L13 = 1.0000
L23 = 0.5000
L12 = 1.0000
L13 = 1.0000
P12 = 0.2889
P13 = -0.2889
P23 = -1.0111
po =
0
-1.3000
xo =
0.4444 0.1778
0.1778 0.3111
del =
-0.2311
-0.4044
limp =
1.4000 0.6000 0.8000
0.6000 1.0000 0.4000
0.8000 0.4000 1.2000
p12 = 0.2889
P13 = -0.2889
P23 = -1.0111
32
PS5111-Power System Simulation Laboratory
THEORY :
i 1 i
Where Fi =αi + βiPi + γiPi2
33
PS5111-Power System Simulation Laboratory
N
Let PLOAD Pi 0
i 1
By making use of Lagrangian multiplier the auxiliary function is obtained as
N
L FT , i.e, L FT PLOAD Pi
i 1
Lagrangian Multiplier
differentiating L wrt Pi and equating to zero
L Fi Pi
(0 1) 0
Pi Pi
Fi
Pi
the condition for optimum operation is
F1 F2 F
.......................... N
P1 P2 PN
Fi
is the Incremental production cost of the unit i
Pi
TRANSMSSION N/W
WITH LOSSES
PLOSS
34
PS5111-Power System Simulation Laboratory
i 1 i
Subjected to the following constraints
Equality Constraint,
N
PLOAD PLOSS Pi
i 1
N – Number of generating units
PLOAD -Total load of the system
PLOSS -Total Network losses of the system.
In Equality Constraint,
Pi, min Pi Pi, max
Pi, min_--- Minimum Power generation from plant i.
Pi, max -- Maximum Power generation from plant i.
L Fi P P N P
( LOAD LOSS i ) 0
Pi Pi Pi Pi i 1 Pi
Fi P
0 LOSS 1 0
Pi Pi
Fi P
LOSS Coordination Equation
Pi P
i
PLOSS
= Incremental Transmission loss at plant i
Pi
= Incremental production cost (Rs/MWHr)
35
PS5111-Power System Simulation Laboratory
λ=
2.Find the value of power output of all the generators by using the formula
given below
Pi =
3.Check the value of power residue .If it is zero then stop the iteration and
print the optimal schedule otherwise go to next step.
ΔP= Pload -
4.Calculate the change in λ and update the value of λ by using the equations
given below,
Δλ =
λ new= λ + Δλ
5.Go to step 2
λ=
2.Find the value of power output of all the generators by using the formula
given below
Pi =
3.Check the value of power residue .If it is zero then stop the iteration and
print the optimal schedule otherwise go to next step.
ΔP= Pload - +
4.Calculate the change in λ and update the value of λ by using the equations
given below,
Δλ =
λ new= λ + Δλ
5.Go to step 2
PROBLEM
36
PS5111-Power System Simulation Laboratory
1.The given cost function of the 3 Generating units are given below,
C1 = 561+7.92+0.001562P12 Rs/Hr
C2 = 310+7.85P2+0.00194P22 Rs/Hr
C3 = 78+7.97P3+0.00482P32 Rs/Hr
where P1, P2, P3 are in MW. The total system load is PD = 975MW. The MW
limits of the generating units are given below,
150 P1 600
100 P2 400
50 P3 200
The fuel cost of all the unit is 1 Rs/MBtu.The generating units contribute to
satisfy a load demand of 850 MW. The loss expression is given as
Ploss=0.00003P12 +0.0000982P22+0.00012P32 in MW.
PROGRAM
clc;
clear all;
n=input('Enter the number of generating units');
for i=1:n
disp('Enter the details for the unit');
disp(i);
a(i)=input('Enter the coefficient of Pg^2');
b(i)=input('Enter the coefficient of Pg');
pmin(i)=input('Enter the pmin value');
pmax(i)=input('Enter the pmax value');
end
pd=input('Enter the demand value');
lam=input('Enter the starting value of lambda');
delp=-1;
iteration=0;
q=input('Enter 1 for ED without losses & 2 for ED with losses');
if q==1
while delp~=0
pp=0;
x=0;
for i=1:n
p(i)=(lam-b(i))/(2*a(i));
if p(i)<pmin(i)
p(i)=pmin(i);
end
if p(i)>pmax(i)
p(i)=pmax(i);
else
p(i)=p(i);
37
PS5111-Power System Simulation Laboratory
end
x=x+(1/(2*a(i)));
pp=pp+p(i);
end
delp=pd-pp;
dellam=delp/x;
lam=lam+dellam;
iteration=iteration+1;
if iteration==1000
break;
end
disp('iteration=');
disp(iteration);
disp('Power of the unit');
disp(p);
disp('Lambda=');
disp(lam);
end
else
for i=1:n
for j=1:n
B(i,j)=input('Enter the value');
end
end
while delp~=0
pp=0;
x=0;
ploss=0;
for i=1:n
p(i)=(lam-b(i))/(2*(a(i)+(lam*B(i,i))));
if p(i)<pmin(i)
p(i)=pmin(i);
end
if p(i)>pmax(i)
p(i)=pmax(i);
else
p(i)=p(i);
end
pp=pp+p(i);
x=x+(a(i)+(B(i,i)*b(i)))/(2*(a(i)+(lam*B(i,i)))^2);
end
ploss=(p*B*transpose(p));
delp=ploss+pd-pp;
dellam=delp/x;
lam=lam+dellam;
iteration=iteration+1;
if iteration==1000
38
PS5111-Power System Simulation Laboratory
break;
end
disp('iteration=');
disp(iteration);
disp('Power of the unit');
disp(p);
disp('lambda');
disp(lam);
end
end
39
PS5111-Power System Simulation Laboratory
OUTPUT
OUTPUT:
WITH LOSSES:
Enter the number of generating units3
Enter the details for the unit 1
Enter the coefficient of Pg^2 0.001562
Enter the coefficient of Pg 7.92
Enter the pmin value 150
Enter the pmax value 600
Enter the details for the unit 2
Enter the coefficient of Pg^2 0.00194
Enter the coefficient of Pg 7.85
Enter the pmin value 100
Enter the pmax value 400
Enter the details for the unit 3
Enter the coefficient of Pg^2 0.004823
Enter the coefficient of Pg 7.97
Enter the pmin value 50
Enter the pmax value 200
Enter the demand value 850
Enter the starting value of lambda 7
Enter 1 for ED without losses & 2 for ED with losses 1
iteration= 999
Power of the unit
393.2055 334.6325 122.1619
Lambda= 9.1484
40
PS5111-Power System Simulation Laboratory
WITHOUT LOSSES:
Enter the number of generating units 3
Enter the details for the unit 1
Enter the coefficient of Pg^2 0.001562
Enter the coefficient of Pg 7.92
Enter the pmin value 150
Enter the pmax value 600
Enter the details for the unit 2
Enter the coefficient of Pg^2 0.00194
Enter the coefficient of Pg 7.85
Enter the pmin value 100
Enter the pmax value 400
Enter the details for the unit 3
Enter the coefficient of Pg^2 0.00482
Enter the coefficient of Pg 7.97
Enter the pmin value 50
Enter the pmax value 200
Enter the demand value 850
Enter the starting value of lambda 7
Enter 1 for ED without losses & 2 for ED with losses 2
Enter the value0.00003
Enter the value0
Enter the value0
Enter the value0
Enter the value0.00009
Enter the value0
Enter the value0
Enter the value0
Enter the value0.00012
iteration=99
Power of the unit
41
PS5111-Power System Simulation Laboratory
VIVA Questions
1. What is Equal incremental cost?
2. What are the various constraints in ED Problem?
3. What is Power Balance constraint?
4. What is loss Coefficients in ED problem?
42
PS5111-Power System Simulation Laboratory
ALGORITHM:
Priority-List Method:
It consist of a simple shut-down rule obtained by an exhaustive enumeration of all unit
combinations at each load level or obtained by noting the full-load average production
cost of each unit The full-load average production cost is the net heat rate at full load
multiplied by the fuel cost .Various enhancements can be made to the priority-list scheme
by the grouping of units to ensure that various constraints are met.
Typical shut-down rules:
1. At each hour when load is dropping, determine whether dropping the next unit on
the list leaves sufficient generation to supply the load plus the spinning-reserve
requirements
4. If the time is less than the minimum shut-down time for the unit, keep it
committed.
5. Perform a cost comparison for the sum of the hourly production costs for the next
number of hours with the next unit to be dropped being committed and the sum of
the restart costs for the next unit based on the minimum cost of cooling the unit or
banking the unit ‘
THEORY:
Unit Commitment, further abbreviated as UC, refers to the strategic choice to be made in
order to determine which of the available power plants should be considered to supply
electricity. UC is not the same as dispatching. Dispatching consists of fitting a given set of
power plants into a certain electric demand. UC appoints the set of plants from which
dispatching can choose. The difference between both issues is time. In dispatching
decisions, there is no time to rapidly activate a power plant because the inertia of most
plants will not allow this. UC therefore prepares a set of plants and stipulates in which
time period they have to be on-line and ready for dispatching.
UC chooses plants taking into account a wide variety of parameters, technological
aspects (such as minimal operation point, minimum up and down time and transient
behavior) as well as economical considerations (such as start-up costs and operational
costs) and social elements (such as availability of staff and work-schemes). UC
optimization enables utilities to minimize electricity generation costs.
THREE EXISTING METHODS
43
PS5111-Power System Simulation Laboratory
Many strategies have already been developed to tackle the UC economic optimization.
Brute Force Method: The most evident method is what we call brute force in which all
possible combinations of power plants to provide a given demand are calculated. The
possibilities conflicting with the boundary conditions are struck off the list. Finally, the
most economic of all remaining possibilities is withheld. This method is not only
scientifically clumsy but will also amount in the largest possible calculation time.
DP Method: Dynamic programming (DP) is a name used for methods in which a-priori
impossible or improbable possibilities are left out. This Method starts from a previously
determined optimal UC planning and gradually adds power plants to obtain optimal
solutions for higher demand.
Decomposition Method: In this method the main problem is decomposed into several sub-
problems that are easier to solve. In order to take into account uncertainties combine the
DP with fuzzy logic. The neural networks can be used to enable the model to learn from
previously made decisions. · It is possible to decompose UC into a master problem and
sub-problems that can be solved separately. The master problem is optimized (minimal
cost), linking the sub-problems by Lagrange multipliers.
Priority Listing Method: A very simple method is based on Priority Listing in which
power plants are logically ranked. Originally, the plants were ranked according to full
load cost. All plants are initially activated. Then they are shut down one at a time to check
whether or not the overall costs are reduced.
Next to these conservative methods, also some unconventional methods like genetic
algorithms can be used. This is a stochastic adaptive search based on "survival of the
fittest".
Exercise
Obtain the optimal Unit Commitment for the given generators using Priority list technique
Unit1:Pmin=150MW ;Pmax=600MW
Fuel Cost function H1=510+7.2P1+0.00142P12 MBtu/Hr
Unit2:Pmin=100MW ;Pmax=400MW
Fuel Cost function H2=310+7.85P2+0.00142P22 MBtu/Hr
Unit1:Pmin=150MW ;Pmax=600MW
Fuel Cost function H3=78+7.97P3+0.004822P32 MBtu/Hr
With
Fuel cost 1=1.1 R/MBtu
Fuel cost 2=1.0 R/MBtu
Fuel cost 3=1.2 R/MBtu
RESULT:
Thus the optimal unit commitment Schedule is obtained using priority listing method
Viva Questions:
1. What is Unit Commitment?
2. What are the various constraints in unit commitment?
3. Define spinning reserve constraint.
4. What are crew constraints?
5. What is priority listing?
44
PS5111-Power System Simulation Laboratory
PROGRAM
clc;
clear all;
n=input('Enter the number of generating units');
for i=1:n
disp('Enter the details for unit');
disp(i);
a1(i)=input('Enter the coefficient of Pg^2');
b1(i)=input('Enter the coefficient of Pg');
c1(i)=input('Enter the coefficient ');
pmin(i)=input('Enter the Pmin value');
pmax(i)=input('Enter the Pmax value');
k(i)=input('Enter the fuel cost');
a(i)=(k(i)*a1(i));
b(i)=(k(i)*b1(i));
c(i)=(k(i)*c1(i));
end
for i=1:n
FLAPC(i)=(k(i)*(c1(i)+(b1(i)*pmax(i))+(a1(i)*pmax(i)^2)))/pmax(i);
end
FLAPC
for i=1:n
for j=i+1:n
if FLAPC(j)<FLAPC(i)
temp1=FLAPC(i);
FLAPC(i)=FLAPC(j);
FLAPC(j)=temp1;
temp2=pmin(i);
pmin(i)=pmin(j);
pmin(j)=temp2;
temp3=pmax(i);
pmax(i)=pmax(j);
pmax(j)=temp3;
temp4=a(i);
a(i)=a(j);
a(j)=temp4;
temp5=b(i);
b(i)=b(j);
b(j)=temp5;
temp7=c(i);
c(i)=c(j);
c(j)=temp7;
end
end
end
FLAPC
u=n;
for i=1:n
m1=0;
m2=0;
45
PS5111-Power System Simulation Laboratory
for k=1:u
m1=m1+pmin(k);
m2=m2+pmax(k);
end
u=u-1;
psmin(i)=m1;
psmax(i)=m2;
end
psmin
psmax
lam=input('Enter the initial value of lambda');
pd=input('Enter the Pd value');
u=n;
for i=1:n
if psmax(i)>pd
delp=-1;
iteration=0;
while delp~=0
pp=0;
x=0;
for i=1:u
p(i)=(lam-b(i))/(2*a(i));
if p(i)<pmin(i)
p(i)=pmin(i);
end
if p(i)>pmax(i)
p(i)=pmax(i);
else
p(i)=p(i);
end
x=x+(1/(2*a(i)));
pp=pp+p(i);
end
for i=1:u
for j=i+1:u
if FLAPC(j)<FLAPC(i)
temp6=p(i);
p(i)=p(j);
p(j)=temp6;
end
end
end
for k=1:u
f(k)=(c(k)+(b(k)*p(k))+(a(k)*p(k)^2));
end
tot=0;
for k=1:u
tot=tot+f(k);
end
delp=pd-pp;
46
PS5111-Power System Simulation Laboratory
dellam=delp/x;
lam=lam+dellam;
if iteration==100
break;
end
iteration=iteration+1;
end
u=u-1;
end
disp('For the combination ');
disp(i);
disp('Total Fuel Cost=');
disp(tot);
disp('At the end of Iteration=');
disp(iteration);
disp('Power of the units');
disp(p);
disp('lambda=');
disp(lam);
p=zeros(1,n);
lam=0;
tot=0;
end
47
PS5111-Power System Simulation Laboratory
OUTPUT
Enter the number of generating units3
48
PS5111-Power System Simulation Laboratory
State Estimation
Aim:
To obtain the bests possible estimate of state of the power system for the given set
of measurement by weighted least squares method.
State Estimation BY WLSE method
State estimation plays a very important role in the monitoring and control of
modern power system. The main aim of this is to obtain the voltages and bus angles by
processing the available system data.
State estimation is defined as the data processing algorithm for converting
redundant meter reading and other available information into as estimate of the state of
electrical power system.
Real time measurement are collected in power system through SCADA system.
Typical data includes real and reactive line flows and real and reactive bus injections and
bus voltage magnitude. This telemetered data may contain errors. Theseerrors render the
outputuseless. It is for this reason that, power system state estimation techniques have
been developed.
A commonly used criterion is that of minimizing the sum of the squares of the
differences between estimated measurement quantities and actual measurement. This is
known as “weighted least squares” criterion. The mathematical model of state estimation
is based on the relation between the measurement variable and the state variable.
Let
[Z] = Set of measurements
[X] = The vector of state variables
[f(X] = The equation relating measurement
variables to the state variable
[e] = The measurement error vector
We have
[Z] = [f(x)+[e] →
(1)
The errors [e1,e2,….em]T are assumed to be independent random variable with
Gaussian distribution whose mean is zero. The variationmeasurement errorσiprovides an
indication of the certainity about the particular measurements. A large variance indicates
that the corresponding measurement accurate.
The objective function to be minimsed
→
(2)
Here m is the number of measurements
Minimise
J(x)={[f(x)-[Z]}T [W}[f(X/]-[Z]}
Linearsing equation (1) and simultaneously minimizing the objective
function (3), We get state correction vector as
[ΔX]={[H][W][H]-1[H][W]{[Z]-F9X)]}}
(4)
Where
49
PS5111-Power System Simulation Laboratory
The correction vector [ΔX] should be computed using the latest available system
state must be checked for convergence.
Algorithm:
Read all the relevant data
Initialize the state vector
Compute measurement function [f(x)] and Jocobian matrix [H] using latest known system
state variable
Check weather all the elements of [ΔX] are within the tolerance value, if so latest [X] is
the present system state or else go to next step.
Update the state vector
[X]=[X0]+[ΔX] and go to step 3
Line data
Line number Start Bus End bus Reactance in p.u
1 1 2 0.2
2 2 3 0.4
3 1 3 0.25
Measurement Data:
S.No Measurement Quanities Values (p.u) Weightages
1 P1 0.72 1.0
2 P1,2 0.68 1.0
3 P3,2 -0.405 0.1
4 P1,3 -0.04 0.2
Program:
num = 3;
ybus = ybusppg(num);
zdata = zdatas(num);
bpq = bbusppg(num);
nbus = max(max(zdata(:,4)),max(zdata(:,5)));
type = zdata(:,2);
z = zdata(:,3);
fbus = zdata(:,4);
tbus = zdata(:,5);
50
PS5111-Power System Simulation Laboratory
Ri = diag(zdata(:,6));
V = ones(nbus,1);
del = zeros(nbus,1);
E = [del(2:end); V];
G = real(ybus);
B = imag(ybus);
vi = find(type == 1);
ppi = find(type == 2);
qi = find(type == 3);
pf = find(type == 4);
qf = find(type == 5);
nvi = length(vi);
npi = length(ppi);
nqi = length(qi);
npf = length(pf);
nqf = length(qf);
iter = 1;
tol = 5;
while(tol> 1e-4)
h1 = V(fbus(vi),1);
h2 = zeros(npi,1);
h3 = zeros(nqi,1);
h4 = zeros(npf,1);
h5 = zeros(nqf,1);
fori = 1:npi
m = fbus(ppi(i));
for k = 1:nbus
h2(i) = h2(i) + V(m)*V(k)*(G(m,k)*cos(del(m)-del(k)) + B(m,k)*sin(del(m)-
del(k)));
end
end
fori = 1:nqi
m = fbus(qi(i));
for k = 1:nbus
h3(i) = h3(i) + V(m)*V(k)*(G(m,k)*sin(del(m)-del(k)) - B(m,k)*cos(del(m)-
del(k)));
end
end
fori = 1:npf
m = fbus(pf(i));
n = tbus(pf(i));
h4(i) = -V(m)^2*G(m,n) - V(m)*V(n)*(-G(m,n)*cos(del(m)-del(n)) -
B(m,n)*sin(del(m)-del(n)));
end
fori = 1:nqf
m = fbus(qf(i));
n = tbus(qf(i));
h5(i) = -V(m)^2*(-B(m,n)+bpq(m,n)) - V(m)*V(n)*(-G(m,n)*sin(del(m)-del(n)) +
B(m,n)*cos(del(m)-del(n)));
end
51
PS5111-Power System Simulation Laboratory
r = z - h;
H11 = zeros(nvi,nbus-1);
H12 = zeros(nvi,nbus);
for k = 1:nvi
for n = 1:nbus
if n == k
H12(k,n) = 1;
end
end
end
H21 = zeros(npi,nbus-1);
fori = 1:npi
m = fbus(ppi(i));
for k = 1:(nbus-1)
if k+1 == m
for n = 1:nbus
H21(i,k) = H21(i,k) + V(m)* V(n)*(-G(m,n)*sin(del(m)-del(n)) +
B(m,n)*cos(del(m)-del(n)));
end
H21(i,k) = H21(i,k) - V(m)^2*B(m,m);
else
H21(i,k) = V(m)* V(k+1)*(G(m,k+1)*sin(del(m)-del(k+1)) -
B(m,k+1)*cos(del(m)-del(k+1)));
end
end
end
H22 = zeros(npi,nbus);
fori = 1:npi
m = fbus(ppi(i));
for k = 1:(nbus)
if k == m
for n = 1:nbus
H22(i,k) = H22(i,k) + V(n)*(G(m,n)*cos(del(m)-del(n)) +
B(m,n)*sin(del(m)-del(n)));
end
H22(i,k) = H22(i,k) + V(m)*G(m,m);
else
H22(i,k) = V(m)*(G(m,k)*cos(del(m)-del(k)) + B(m,k)*sin(del(m)-del(k)));
end
end
end
52
PS5111-Power System Simulation Laboratory
H32 = zeros(nqi,nbus);
fori = 1:nqi
m = fbus(qi(i));
for k = 1:(nbus)
if k == m
for n = 1:nbus
H32(i,k) = H32(i,k) + V(n)*(G(m,n)*sin(del(m)-del(n)) - B(m,n)*cos(del(m)-
del(n)));
end
H32(i,k) = H32(i,k) - V(m)*B(m,m);
else
H32(i,k) = V(m)*(G(m,k)*sin(del(m)-del(k)) - B(m,k)*cos(del(m)-del(k)));
end
end
end
H41 = zeros(npf,nbus-1);
fori = 1:npf
m = fbus(pf(i));
n = tbus(pf(i));
for k = 1:(nbus-1)
if k+1 == m
H41(i,k) = V(m)* V(n)*(-G(m,n)*sin(del(m)-del(n)) + B(m,n)*cos(del(m)-
del(n)));
elseif k+1 == n
H41(i,k) = -V(m)* V(n)*(-G(m,n)*sin(del(m)-del(n)) + B(m,n)*cos(del(m)-
del(n)));
else
H41(i,k) = 0;
end
end
end
end
H42(i,k) = 0;
end
end
end
end
H51 = zeros(nqf,nbus-1);
fori = 1:nqf
m = fbus(qf(i));
n = tbus(qf(i));
for k = 1:(nbus-1)
if k+1 == m
H51(i,k) = -V(m)* V(n)*(-G(m,n)*cos(del(m)-del(n)) - B(m,n)*sin(del(m)-
del(n)));
elseif k+1 == n
H51(i,k) = V(m)* V(n)*(-G(m,n)*cos(del(m)-del(n)) - B(m,n)*sin(del(m)-
del(n)));
else
H51(i,k) = 0;
end
end
end
end
H52 = zeros(nqf,nbus);
fori = 1:nqf
m = fbus(qf(i));
n = tbus(qf(i));
for k = 1:nbus
if k == m
H52(i,k) = -V(n)*(-G(m,n)*sin(del(m)-del(n)) + B(m,n)*cos(del(m)-del(n))) -
2*V(m)*(-B(m,n)+ bpq(m,n));
elseif k == n
H52(i,k) = -V(m)*(-G(m,n)*sin(del(m)-del(n)) + B(m,n)*cos(del(m)-del(n)));
else
H52(i,k) = 0;
end
end
end
end
H = [H11 H12; H21 H22; H31 H32; H41 H42; H51 H52];
Gm = H'*inv(Ri)*H;
J = sum(inv(Ri)*r.^2);
dE = inv(Gm)*(H'*inv(Ri)*r);
E = E + dE;
del(2:end) = E(1:nbus-1);
V = E(nbus:end);
iter = iter + 1;
tol = max(abs(dE));
end
CvE = diag(inv(H'*inv(Ri)*H));
Del = 180/pi*del;
54
PS5111-Power System Simulation Laboratory
E2 = [V Del];
disp('-------- State Estimation ------------------');
disp('--------------------------');
disp('| Bus | V | Angle | ');
disp('| No | pu | Degree | ');
disp('--------------------------');
for m = 1:n
fprintf('%4g', m); fprintf(' %8.4f', V(m)); fprintf(' %8.4f', Del(m)); fprintf('\n');
end
disp('---------------------------------------------');
functionbbus = bbusppg(num)
linedata = linedatas(num);
fb = linedata(:,1);
tb = linedata(:,2);
b = linedata(:,5);
nbus = max(max(fb),max(tb));
nbranch = length(fb);
bbus = zeros(nbus,nbus);
for k=1:nbranch
bbus(fb(k),tb(k)) = b(k);
bbus(tb(k),fb(k)) = bbus(fb(k),tb(k));
end
functionybus = ybusppg(num) % Returns ybus
linedata = linedatas(num);
fb = linedata(:,1);
tb = linedata(:,2);
r = linedata(:,3);
x = linedata(:,4);
b = linedata(:,5);
a = linedata(:,6);
z = r + i*x;
y = 1./z;
b = i*b;
nbus = max(max(fb),max(tb));
nbranch = length(fb);
ybus = zeros(nbus,nbus);
for k=1:nbranch
ybus(fb(k),tb(k)) = ybus(fb(k),tb(k))-y(k)/a(k);
ybus(tb(k),fb(k)) = ybus(fb(k),tb(k));
end
for m =1:nbus
for n =1:nbranch
if fb(n) == m
ybus(m,m) = ybus(m,m) + y(n)/(a(n)^2) + b(n);
elseiftb(n) == m
ybus(m,m) = ybus(m,m) + y(n) + b(n);
end
end
end
55
PS5111-Power System Simulation Laboratory
functionrect = pol2rect(rho,theta)
rect = rho.*cos(theta) + j*rho.*sin(theta);
RESULT:
The state of the given system has estimated using weighted least square method
and the results are found to be correct
56
PS5111-Power System Simulation Laboratory
Exp.No:8 Date
To become proficient in the image of EMTP to address problems in the areas of over
voltages protection and mitigation and insulation coordination of EHV systems.
Objective:
The study of transients due to energization of a long distributed parameters line from an
ideal 230kV source.
Software Required :
PSCAD
Theory:
Solution method for electromagnetic transient analysis Intentional and inadvertent
switching operations in EHV system initiate over voltages, which might obtain dangerous
value resulting in distinction of observation.
Accurate Computation of these over voltages is essential for proper sizing co ordination of
insulation of various equipments and specification of protection devices.
Simulation:
57
PS5111-Power System Simulation Laboratory
Result:
The study of transient due to energization of a long distributed parameter line has been
performed.
58
PS5111-Power System Simulation Laboratory
Exp.No: 9 Date
To become proficient in the image of EMTP to address problems in the areas of over
voltages protection and mitigation and insulation coordination of EHV systems.
Objective:
The study the transients Recovery Voltage (TRV) associated with a breaker for a 3 phase
fault.
Software Required :
PSCAD
Theory:
Solution method for electromagnetic transient analysis:
Intentional and inadvertent switching operations in EHV system initiate over voltages,
which might obtain dangerous value resulting in distinction of apparatus.
Accurate Computation of these over voltages is essential for proper sizing co ordination of
insulation of various equipments and specification of protection devices.
The program emphasis a direct integration time domain technique. The Essence of this
method is discrimination of differential equation associated with network elements using
trapezoidal rate of integration and solution of the resulting difference equation for the
unknown voltages.
59
PS5111-Power System Simulation Laboratory
Simulation :
Result:
The the transient recovery voltage in each phase for a 3 phase fault was obtained by
PSCAD.
60
PS5111-Power System Simulation Laboratory
AIM:
To design and study of voltage source inverter by using a MATLAB Simulink.
Theory:
DC to AC converters is known as converters. The function of an inverter is to
change a DC input voltage to a symmetric AC input voltage of desired magnitude and
frequency. The output voltage could be fixed or variable at a fixed or variable frequency.
A variable output voltage can be obtained by varying the input DC voltage is fixed and it
is not controllable, a variable output voltage can be obtained by varying the gain of the
inverter, which is normally accomplished by pulse wudth modulation control within the
inverter. The inverter gain may be defined as the ratio of the AC output voltage to the DC
input voltage.
The output voltage waveform of the ideal inverter should be sinusoidal. However
,the waveform of practical inverters are non sinusoidal.
Inverters are widely used in industrial applications. The input may be battery etc.,
They are broadly classified as
1. Single phase inverters
2. Three phase inverters
Each type can use controlled turn ON and OFF devices. These inverters generally
use PWM control signal for producing an AC output voltage. An inverter called
voltage fed inverter, if input voltage remains constant and called current fed
inverters, if current remains constant.
Circuit demonstration:
61
PS5111-Power System Simulation Laboratory
CIRCUIT:
Continuous
+
v
powergui -
Pulse Pulse Pulse Voltage Measurement
Generator Generator1 Generator2 +
v
-
Voltage Measurement1
D
D
g
g
+
v
- Scope
Mosfet Mosfet1 Mosfet2 Voltage Measurement2
m
m
S
S
Terminator5 Terminator4 Terminator3
DC Voltage Source
Series RLC Branch
D
D
g
Pulse Pulse
Pulse
Mosfet3
Generator3 Mosfet4
Generator4 Mosfet5
Generator5
Series RLC Branch2
m
m
S
+
v
-
Voltage Measurement4
Scope1
+
v
-
Voltage Measurement5
OUTPUT:
62
PS5111-Power System Simulation Laboratory
Demonstration
Run the simulation and observe the following two waveforms on the three Scope blocks:
current into the load (trace 1), voltage generated by the PWM inverter (trace 2).
Once the simulation is completed, open the Powergui and select "FFT Analysis" to
display the 0 - 5000 Hz frequency spectrum of signals saved in the three
"psb1phPWMx_str" structures. The FFT will be performed on a 2-cycle window starting
at t = 0.1 - 2/60 (last 2 cycles of recording). For each circuit, select Input labeled "V
inverter" . Click on "Display" and observe the frequency spectrum of last 2 cycles.
The half-bridge inverter generates a bipolar voltage (-200V or +200V) . Harmonics occur
around the carrier frequency (1080 Hz +- k*60 Hz), with a maximum of 103% at 1080
Hz.
The full-bridge inverter generates a monopolar voltage varying between 0 and+400V for
one half cycle and then between 0 and -400V for the next half cycle. For the same DC
voltage and modulation index, the fundamental component magnitude is twice the value
obtained with the half-bridge. Harmonics generated by the full-bridge are lower and they
appear at double of the carrier frequency (maximum of 40% at 2*1080+-60 Hz) As a
result, the current obtained with the full-bridge is "cleaner".
If you now perform a FFT on the signal "Iload" you will notice that the THD of load
current is 7.3% for the half-bridge inverter as compared to only 2% for the full-bridge
inverter.
Result:
Thus the voltage source inverter was studied and designed.
63
PS5111-Power System Simulation Laboratory
Ex.No;11 Date:
Aim:
In this laboratory you will use the PSCAD example case provided to study and verify the
following:
Introduction
The case provided shows a 230 kV substation feeding a 33 kV radial distribution network.
Coordinated over-current (inverse time) relays at the breakers B12, B23 and B34 are used
to discriminate the faults at different locations and provide backup protection.
Generator
You may recall that the settings of the time overcurrent relays are adjusted in such a way
that the breaker nearest to the fault is tripped in the shortest possible time, and then the
remaining breakers are tripped in succession using longer time delays, moving backwards
64
PS5111-Power System Simulation Laboratory
towards the source. We will use the following principle for coordinated operation of the
overcurrent relays:
For any relay X, backing up the next downstream relay Y, is that X must pick up
All the relays in the PSCAD case provided use the IEC standard inverse current
characteristics and the curves are provided at the end of instruction sheet. As explained in
the class the inverse time relays can be adjusted by selecting two parameters- the pick-up
or the plug settings (tap settings) and the time dial settings (or time multiplier settings –
TMS).
The pick-up settings are used to define the pick up current of the relay. For example, the
tap settings of the electromechanical overcurrent relay that was discussed in the class was
1.0, 1.2, 1.5, 2.0, 3.0, 4.0, 5.0, 6.0, 7.0, 8.0, 10.0, 12.0 A. We will use these discrete
values in the PSCAD simulation case provided as well. This way we can make a
comparison with the hand calculated values from the characteristic curves shown in the
graph paper. However, you should be aware of the fact that the modern relays are of the
digital type and the pick-up settings of IEC characteristics can be varied in a continuous
fashion.
The time dial setting adjusts the time delay before the relay operates whenever the fault
current reaches a value equal to, or greater than, the relay current setting. In
electromechanical relays, the time delay is usually achieved by adjusting the physical
distance between the moving and fixed contacts, and is also specified as discrete settings.
In Figure 2, a time-dial setting of 0.1 produces the fastest operation of the relay, whereas
a setting of 1 produces the slowest operation for a given current. For digital relays,
similar to the pick-up settings, the time-dial settings can be used in a continuous fashion
but we will assume in this laboratory that the time multiplier settings are discrete.
65
PS5111-Power System Simulation Laboratory
Laboratory Exercise
1. Bypass all relays using the bypass switches on the control panel. Record the
maximum fault currents seen at the Bus 2, 3 and 4. Use the timed fault logic to
apply the fault at 2.0s for a period longer than the simulation run to record the
fault currents. Keep the fault resistance at 0.001 .
2. Again bypass all relays using the bypass switches on the control panel and this
time apply line-line and line-to-ground permanent fault at Bus 2, 3 and 4. Record
the fault currents seen by the relays for the two types and note the minimum value
(note that the minimum fault currents are obtained for line-line or line-ground
faults). Use the timed fault logic to apply the fault at 2.0s for a period longer than
the simulation run to record the fault currents. Keep the fault resistance at 0.001
.
3. Use the obtained fault currents to determine the appropriate CT ratios and the
relay settings for the three breakers (follow the method that was explained to you
in the class).
Laboratory Exercise
1. Put all relays back into operation by reverting the position of the bypass switches.
Apply a solid permanent three-phase fault on Bus-4. Examine the fault current
values, primary relay operation and its operating time. Check whether the
operation of primary protection is as expected and according to your settings.
2. Repeat step 1 with fault resistance of 20 .
3. Repeat step 1 with A-B and A-G faults. Keep the fault resistance at 0.001 .
4. Remove the fault at Bus-4. Repeat step 1 for faults at Bus-3 and Bus-2.
5. Bypass the relay at breaker (B34) and apply a solid three-phase fault on Bus-4.
Examine whether the backup protection (B23) clears the fault. Record the
operating time of the backup relay and verify it with it with hand calculations
using the graph provided.
6. Bypass the relay at breaker (B23) and study the operation of backup protection
(relay at breaker B12) by applying a solid three-phase fault on Bus-3. Examine
whether the backup protection clears the fault. Record the operating time of the
backup relay.
66
PS5111-Power System Simulation Laboratory
Effect of CT Saturation
In this part of the laboratory we will briefly investigate the effect of CT saturation on the
operating times of the overcurrent relays. CT saturation strongly depends on the fault
current levels, CT secondary burden and the presence of dc offset currents in the
waveform, size of the CT core.
Laboratory Exercise
1. Revert all relays back into operation. Change the burden of the CTs of relay at
B34 to 5 . Apply a solid three-phase fault at Bus-4. Observe the primary and
secondary currents of the CT at B34. Observe the relay operating time and
compare with the values obtained in Section 3. Comment on your observation.
2. Change the fault type to an asymmetrical type of fault (A-G). Apply the fault at
2.0s and record the relay operating time. Repeat the simulation now with fault
applied at 2.0042 s and compare the relay operating time with the previous case.
Comment on your observation – discuss with your instructor.
67
PS5111-Power System Simulation Laboratory
Result:
68
PS5111-Power System Simulation Laboratory
Ex.N0:12
AIM:
To analyse the relay coordination for radial line protection using ETAP 7.5.0.
THEORY:
Power system protection performs the function of fault detection and clearing as
soon as possible, isolating whenever possible only the faulted component or a minimal
set of components in any other case. Since the main protection system may fail (relay
fault or breaker fault), protections should act as backup either in the same station or in the
neighboring lines with time delay according to the selectivity requirement. The
determination of the time delays of all backup relays is known as coordination of the
protection system.
Coordination of protective relays is necessary to obtain selective tripping. The first rule
of protective relaying is that the relay should trip for a fault in its zone. The second rule is
that the relay should not trip for a fault outside its zone, except to back up a failed relay
or circuit breaker. To coordinate this backup protection with the primary relay
characteristic will ensure that the backup relay has sufficient time delay to allow the
primary relay (and its breaker) to clear the fault. Several methods have been proposed for
the coordination of over current relays.
69
PS5111-Power System Simulation Laboratory
70
PS5111-Power System Simulation Laboratory
OC RELAY
71
PS5111-Power System Simulation Laboratory
72
PS5111-Power System Simulation Laboratory
73
PS5111-Power System Simulation Laboratory
74
PS5111-Power System Simulation Laboratory
75
PS5111-Power System Simulation Laboratory
76
PS5111-Power System Simulation Laboratory
77
PS5111-Power System Simulation Laboratory
or higher if coordination considerations dictate that. Values up to600% are allowed by the
IEC, depending on system parameters and what other protective devices are used.
2. Instantaneous pickup is greater than or equal to 160% of short circuit current for
maximum fault downstream of the transformer to avoid tripping of the primary breaker
COORDINATION EVALUATION
ETAP’s STAR module was used to coordinate the time-current curves associated with
the P121-s protective relays. In this study, there is a maximum of three protective devices
needing to be coordinated at any given time. This occurs when a fault happens in any of
the feeders tied in with the ct transformers. Since all these feeders are identical, the
settings associated with the respective relays will also be identical. There are guidelines
in coordinating these devices. There must be adequate time for the relay to sense the
fault, transmit to the breaker, and open the breaker. If this does not occur in the
downstream device, then the upstream device must perform this function
78
PS5111-Power System Simulation Laboratory
SIMULATION OUTPUT:
RESULT:
Hence, analysis on the relay coordination for radial line protection using ETAP
7.5.0. has been executed.
79
PS5111-Power System Simulation Laboratory
Viva Questions:
1. Explain the circuit of the experiment.
2. What is the function of semaphore indicator?
3. Why are the settings of the earth-fault relays lower than the settings of the
overcurrent relays?
4. Draw an a.c. circuit and d.c. control circuit for two overcurrent and one earth-
fault scheme of protection of a feeder used in practice. How does our
experimental scheme differ from that? Why?
5. What do you understand by time discrimination?
6. What do you understand by overshoot of a relay?
7. What is the significance of resetting time of a relays?
8. What do you understand by back-up protection? Explain remote back-up
protection.
9. How does the source impedance affect the choice of relay to be used in radial
feeder protection?
10. Why are the IDMT relays popular in practice?
11. What are the factors to be considered for deciding settings of phase relays and
ground relays?
80
PS5111-Power System Simulation Laboratory
81
PS5111-Power System Simulation Laboratory
82
PS5111-Power System Simulation Laboratory
Motor
500 kVA Induction machine.
Wound rotor Type.
13.8 kV(L-L) 7.697 kV (Phase)
Irated = 0.02804 [kA]
Inertia = 0.7267 [s]
Stator resistance = 0.005 PU
Rotor Resistance = 0.008 PU
Short Line
Short line of 7.4 km
Z+ = 0.2 E-4 + j0.3 E-3 Ohms/m
Z0 = 0.3 E-3 + j0.1 E-2 Ohms/m
Use default values for the capacitances
Capacitor leg
Capacitor
800 KVars per phase
Note:
1. Use ‘typical’ data for the machine.
2. Plot the currents on either side of the transformer (ia and ib).
3. The input torque to the machine is equal to 80% of the square of the speed.
Derive this signal using control blocks. i.e
Tm 0.8 w 2
Use control blocks to implement the above equation.
The wound rotor machine is used.
The motor is started from zero speed.
The mechanical torque applied, Tm, is varied as a function of speed.
ie. Tm = Tload = k*w*w + b
w = speed
83
PS5111-Power System Simulation Laboratory
k,b = constants.
The machine accelerates if Te>Tm
At 3s, the mechanical torque is switched to 1.8 pu using a ‘controlled’ switch.
The machine goes through a transient state and settles at a new speed.
The start up characteristics depends on the external resistance, Rrotor,
connected to the rotor. This value can be changed using a 'slider'. Parameters
such as machine inertia, damping can also be changed inside the component
to study their impact on start up.
84
PS5111-Power System Simulation Laboratory
Output
85
PS5111-Power System Simulation Laboratory
Result :
This experiment was chosen with the intention of learning PSCAD and using it
effectively in obtaining transient behaviour of three-phase induction machine during
starting. Simulated results have been compared and verified with experimental results on
a test machine
86
PS5111-Power System Simulation Laboratory
87
PS5111-Power System Simulation Laboratory
R T = Ra + R E (12)
XTq = XE + Laqs + L l = XE + Xqs
(13)
XTqd = XE + Lads + Ll = XE + Xds
(14)
2
D = R + XTq XTd
T
(15)
The reactance’s Lads and Laqs are saturated values. In per unit they are equal to the
corresponding inductances.
These equations are nonlinear and have to be linearized for small signal analysis.
Linearized system equations
Expressing equations (11) and (13) in terms of perturbed values, we may write
Δid = m1Δδ + m2Δψfd
(16)
Δi q = n1Δδ + n 2Δψ fd
(17)
EB XTqsinδ0 - R Tcosδ0
m1 =
D (18)
EB R Tsinδ0 + XTdcosδ0
n1 =
D
(19
)
XT¶q Lads
m2 =
D Lads + Lfd
RT Lads
n2 =
D Lads + Lfd
(20)
(21)
By linearizing ψad and ψaq, and substituting them in the above expressions and , we get
Δψfd
Δψ ad = Lads -Δi d +
Lfd
(22)
1
= - m2 Lads Δψfd - m1Lads Δδ
Lfd
(23)
Δψ aq = -Laqs Δi q
(24)
= -n 2 Laqs Δψ fd - n1Laqs Δδ
(25)
Linearizing ifd and substituting for ∆ψad from equation (19) gives
88
PS5111-Power System Simulation Laboratory
Δψ fd - Δψ ad
Δi fd =
Lfd
(26)
1 Lads 1
= 1- + Lads Δψ fd + m1Lads Δδ
Lfd Lfd L fd
(27)
The linearized form of air gap torque Te is given by
ΔTe = ψ ad0 Δi q + i q0Δψ ad - ψ aq0Δi d - i d0Δψ aq
(28)
ΔTe = K1Δδ + K 2Δψfd
(29)
K 1 = n1 ψ ad0 + Laqs i d0 - m1 ψ aq0 + Ladsi q0
(30)
Lads
K 2 = n 2 ψ ad0 + Laqs i d0 - m 2 ψ aq0 + Lads i q0 + i q0
Lfd
(31)
The system equation in the desired final form :
Δωr a11 a12 a13 Δωr
Δδ = a 21 0 0 Δδ
Δψ fd 0 a 32 a 33 Δψ fd
(32)
Where,
K
a11 = - D
2H
(33)
K
a12 = - 1
2H
(34)
K
a13 = - 2
2H
(35)
a21 = ω0 = 2πf0
(36)
ωR
a 32 = 0 fd m1Lads
Lfd
(37)
ω R L
a33 = - 0 fd 1- ads + m 2Lads
Lfd Lfd
(38)
89
PS5111-Power System Simulation Laboratory
1
b11 =
2H
(39)
ω 0 R fd
b 32 =
Ladu
and ΔTm and ΔEfd depend on prime mover and excitation controls. With constant
mechanical input torque, ΔTm =0; with constant exciter output voltage, ΔEfd =0.
(48)
90
PS5111-Power System Simulation Laboratory
E
δ 0 = tan -1 Bdo
EBq0
(49)
1/2
EB = E 2 + E2
Bdo Bqo
(50)
eq0 + R a i q0Lds i d0
i fd0 = ,
Lads
(51)
Efd0 = Ladu i fd0
(52)
ψad0 = Lads -id0 + ifd0
(53)
ψ aq0 = -Laqs i q0
(54)
(c)The next step is to compute incremental saturation factors and the corresponding
saturated values of Lads ,Laqs ,L’ads , and then
R T , XTq , XTd , D
m1 ,m2 ,n1 ,n2
K1 ,K 2
is calculated from the equations (11) and (14).
(d) Finally, compute the elements of matrix A.
91
PS5111-Power System Simulation Laboratory
92
PS5111-Power System Simulation Laboratory
Δed = -R a Δi d + Ll Δi q - Δψ aq
(60)
Δeq = -R a Δi q + Ll Δi d - Δψ ad
Use of Equations to eliminate Δi d , Δi q , Δψad and aq from the above equations in terms
of the state variables and substitution of the resulting expressions for ed and e q in
equation yield
ΔEt = K 5Δδ + K 6Δψfd (61)
Where
e e
K 5 = d0 [-R am1 + Lln1 + Laqsn1 ]+ q0 [-R an1 - L lm1 - L'adsm1 ] (62)
Et0 Et0
e e 1
K 6 = d0 [-R am 2 + Lln 2 + Laqsn 2 ]+ q0 [-R an 2 - Llm 2 + L'ads ( - m 2 )] (63)
Et0 Et0 Lfd
a 34 = -b 32 K A
a 41 = 0
K5
a 42 =
TR
K6
a 43 =
TR
1
a 44 = -
TR
(64)
The complete state space model for the power system , including the excitation system is
given by
93
PS5111-Power System Simulation Laboratory
(65)
94
PS5111-Power System Simulation Laboratory
and generator phase characteristics to be compensated, the PSS would result in a pure
damping torque at all oscillating frequencies.
95
PS5111-Power System Simulation Laboratory
The complete state space model, including the PSS, has the following form
Δωr a11 a12 a13 0 0 0 Δωr
Δδ a 21 0 0 0 0 0 Δδ
Δψ fd 0 a 32 a 33 a 34 0 a 36 Δψ fd
= (67)
Δν1 0 a42 a43 a44 0 0 Δν1
Δν a a52 a53 0 a55 0 Δν 2
2 51
Δν s a61 a62 a63 0 a65 a66 Δν s
96
PS5111-Power System Simulation Laboratory
RESULT:
A MATLAB program was written to analyze the small signal stability of single machine
infinite bus system with field circuit, exciter and power system stabilizer.
97