Pss Lab 4
Pss Lab 4
No :
Date :
COMPUTATION OF TRANSMISSION LINE PARAMETERS
AIM
To determine the transmission line parameters and verify using Matlab software.
SOFTWARE REQUIRED
Matlab7.6 software
ALGORITHM
1. Find the given transmission line is single phase or three phase.
2. If it is single phase get the distance between the conductors.
3. Get the radius of conductor using appropriate formula find L and C.
4. If the given system is three phase classify whether it is symmetrical or unsymmetrical
get the distance between conductors.
5. Using appropriate formula find L and C.
6. If unsymmetrical get the distance between the conductors.
7. Using appropriate formula find L and C.
FORMULA USED
Inductance:
The general formula:
L = 0.2 ln (Dm / Ds) mH / KM
Where,
Dm = geometric mean distance (GMD)
Ds = geometric mean radius (GMR)
Single phase 2 wire system
GMD = D
GMR = re-1/4 = r' = 0.7788 r
Where, r = radius of conductor
Three phase – symmetrical spacing
GMD = D GMR = re-1/4 = r'
Where, r = radius of conductor & GMR = re-1/4 = r' = 0.7788 r
Capacitance:
A general formula for evaluating capacitance per phase in micro farad per km of a
transmission line is given by
C = 0.0556/ ln (Deq / r) μF/km
Where,
GMD is the “Geometric mean distance” which is same as that defined for inductance under
various cases.
EXERCISE: 1
A three phase transposed line has its conductors placed at a distance of 11M, 11 M &
22 M. The conductors have a diameter of 3.625cm Calculate the inductance and capacitance of
the transposed conductors.
(a) Determine the inductance and capacitance per phase per kilometer of the above three lines.
(b) Verify the results using the MATLAB program.
PROGRAM:
OUTPUT
PROGRAM:
L= 0.4914
C= 0.0232
RESULT:
Thus the positive sequence line parameters L and c per phase per kilometer of a three
phase single and double circuit transmission lines for different conductor arrangement were
determined and verified with MATLAB software.
Ex.No :
Date :
FORMATION OF Y-BUS AND Z-BUS MATRICES
AIM
To determine the bus admittance and impedance matrices for the given power system
network using Matlab software.
SOFTWARE REQUIRED
Matlab software
ALGORITHM
Step 1:Start the program.
Step 2: Enter the number of buses ‘N’ in the given system.
Step 3:Enter the given impedance values in N x N matrix form as below
(i). Enter ‘infinity’ for diagonal elements.
z(i,j)=inf for i=j.
(ii). Enter the impedance value of the inter-connecting line between the buses i,j as the
values of all off-diagonal elements. z(i,j)=impedance between ‘i’ and ‘j’ bus for i≠ j .
Step 4:Calculate the Admittance matrix (Y-bus matrix) as below.
(i). The diagonal element corresponding to a particular bus of admittance matrix is
the sum of all the admittances connected to that bus, ie.,
N
Y (i, j )=∑ (1/ z(i , j))
j=1
(ii). The off-diagonal element is the negative of the admittance connected between the
buses, i.e.,
Y (i, j )=(−1/ z(i, j )
Step 5:Find the inverse matrix of the admittance matrix [Y] to find the impedance matrix (Z-bus
matrix) of the system.
Step 6:Print the Admittance matrix [Y] and the impedance matrix [Z].
Step 7:Stop the program.
EXERCISE:
(i) Determine Z bus matrix for the power system network shown in fig. Check the results
obtained using MATLAB.
line data
From To R X B/2
Bus Bus
1 2 0.10 0.20 0.02
1 4 0.05 0.20 0.02
1 5 0.08 0.30 0.03
2 3 0.05 0.25 0.03
2 4 0.05 0.10 0.01
2 5 0.10 0.30 0.02
2 6 0.07 0.20 0.025
3 5 0.12 0.26 0.025
3 6 0.02 0.10 0.01
4 5 0.20 0.40 0.04
5 6 0.10 0.30 0.03
PROGRAM
% Program to form Admittance and Impedance Bus Formation....
clc
fprintf('FORMATION OF BUS ADMITTANCE AND IMPEDANCE MATRIX\n\n')
fprintf('Enter linedata in order of from bus,tobus,r,x,b\n\n')
linedata = input('Enter line data : ');
fb = linedata(:,1); % From bus number...
tb = linedata(:,2); % To bus number...
r = linedata(:,3); % Resistance, R...
x = linedata(:,4); % Reactance, X...
b = linedata(:,5); % Ground Admittance, B/2...
z = r + i*x; % Z matrix...
y = 1./z; % To get inverse of each element...
b = i*b; % Make B imaginary...
OUTPUT
RESULT:
Thus the bus Impedance and admittance matrix for the given system were determined and
verified using MATLAB.
Ex.No :
Date :
LOAD FLOW ANALYSIS USING GAUSS-SEIDAL METHOD
AIM
To perform load flow analysis by Gauss Seidel method with the Matlab software
ALGORITHM
i=1 i=j+1
Step9: If I is less than number of buses, increment i by 1 and go to step 6
Step10: Compare the two successive iteration values for Vi
If Vinew– Vjold< tolerance, go to step 12
Step11: Update the new voltage as
Vnew = Vold + α(Vnew- Vold)
Vnew = Vold
Step12: Compute relevant quantities
N
Slack bus power, S1= Pi-jQi=V*I=Vi* Qical= - Im[ ∑YijVj]
J=1
Line flows, Sij= Pij + Qij
= Vi[Vi*- Vj*]Y*ijseries+|Vi|2Yij*
Ploss= Pij+ Pji
Qloss =Qij+ Qji
Step13: Stop the execution.
EXERCISE:
The figure shows the single line diagram of a simple 3 bus 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 impedances are marked in p.u. The base value is 100kVA. The line
charging susceptances are neglected. Determine the phasor values of the voltage at the load bus
2 and 3.
1) Find the slack bus real and reactive power.
2) Verify the result using MATLAB.
PROGRAM:
%GAUSS SEDIAL
clc
clear all
sb=[1 1 2 4 3]; %input('Enter the starting bus = ')
eb=[2 3 4 3 2]; % input('Enter the ending bus = ')
nl=5; %input(' Enter the number of lines= ')
nb=4; %input(' Enter the number of buses= ')
sa=[1-5j 1.2-4j 1.1-2j 1.2-3j .5-4j]; %input('Enter the value of series impedance =')
Ybus=zeros(nb,nb);
fori=1:nl
k1=sb(i);
k2=eb(i) ;
y(i)=sa(i);
Ybus(k1,k1)=Ybus(k1,k1)+y(i);%+h(i);
Ybus(k2,k2)=Ybus(k2,k2)+y(i);%+h(i);
Ybus(k1,k2)=-y(i);
Ybus(k2,k1)=Ybus(k1,k2);
end
Ybus
PG=[0 .5 .4 .2];
QG=[0 0 .3j .1j];
V=[1.06 1.04 1 1];
Qmin=.05;
Qmax=.12;
fori=1:nb
Pg=PG(i);
Qg=QG(i);
if(Pg==0&&Qg==0)%for slackbus
p=1;
Vt(p)=V(p) ;
end
if(Pg~=0&&Qg==0)%for Generator bus
for q=1:p-1
A=Ybus(p,q)*V(q);
end
B=0;
for q=p:nb
B=B+Ybus(p,q)*V(q);
end
c=V(p)*(A+B);
Q=-imag(c)
OUTPUT:
Ybus =
Q=
Qg =
0 + 0.1200i
Vt =
RESULT
Load flow solution for the given problem was solved using Gauss-Seidal method and
verified using MATLAB software.
Ex.No :
Date :
LOAD FLOW ANALYSIS USING NEWTON RAPHSON METHOD
AIM
To conduct the load flow study on the given power system using Newton Raphson
Method.
ALGORITHM
Step1: Formulate Y-bus matrix.
Step2: Assume flat start for starting voltage solution.
∂i0=0, for i=1,2…….N for all buses except slack bus.
|V °i|=1.0for i=M+1,M+2,…….,N(for all PQ buses).
|V i|=|V i|(spec) for all PV buses and slack bus.
Step3: For load buses, calculate Pical and Qical
Step4: For PV buses, check for Q-limit violation.
If Qi(min)<Qical<Qi(max), the bus acts as P-V bus.
If Qical>Qi(max), Qi(spec)= Qi(max).
If Qical<Qi(min), Qi(spec)= Qi(min), the P-V bus will act as P-Q bus.
Step5: Compute mismatch vector using
∆Pi=Pi(spec)-Pical
∆Qi=Qi(spec)-Qical
Step6: Compute ∆Pi(max)= max|∆ Pi|; i=1,2,…..,N except slack
∆Qi(max)=max|∆Q i|; i=M+1…..N
∂ pi ∂ Pi
∆δ
[ ] ∂|V |
∂Qi
∂|V |
−1 ∆ P
Step8: Obtain state correction vector [ ]
∆V
=[ J ] [ ]
∆Q
Step9: Update state vector using
Vnew=Vold+∆V
∂new=∂old+∆∂
Step10: This procedure is continued until
|∆ Pi|< ϵ∧|∆ Qi|< ϵ ;otherwise go to step 3
EXERCISE:
Reacti
Real Real Reactive
ve
Bu load power Power Voltage
Load
s deman Generatio Generatio Specified
deman
d, PD n, PG n, QG
d, QD
1 2 1 - - V1=1.04
Unspecifi
2 0 0 0.5 1
ed
3 1.5 0.6 0 QG3 = V3 = 1.04
Verify the result using MATLAB
PROGRAM:
%NEWTON RAPHSON METHOD
clc
clear all
sb=[1 1 2]; %input('Enter the starting bus = ')
eb=[2 3 3]; % input('Enter the ending bus = ')
nl=3; %input(' Enter the number of lines= ')
nb=3; %input(' Enter the number of buses= ')
sa=[1.25-3.75j 5-15j 1.667-5j]; %input('Enter the value of series impedance =')
Ybus=zeros(nb,nb);
fori=1:nl
k1=sb(i);
k2=eb(i);
y(i)=(sa(i));
Ybus(k1,k1)=Ybus(k1,k1)+y(i);
Ybus(k2,k2)=Ybus(k2,k2)+y(i);
Ybus(k1,k2)=-y(i);
Ybus(k2,k1)=Ybus(k1,k2);
end
Ybus
Ybusmag=abs(Ybus);
Ybusang=angle(Ybus)*(180/pi);
% Calculation of P and Q
v=[1.06 1 1];
P=[0 0 0];
Q=[0 0 0];
del=[0 0 0];
Pg=[0 0.2 0];
Pd=[0 0 0.6];
Qg=[0 0 0];
Qd=[0 0 0.25];
for p=2:nb
for q=1:nb
P(p)=P(p)+(v(p)*v(q)*Ybusmag(p,q)*cos(del(p)+angle(Ybus(p,q))-del(q)));
Q(p)=(Q(p)+(v(p)*v(q)*Ybusmag(p,q)*sin(del(p)-angle(Ybus(p,q))-del(q))));
Pspe(p)=Pg(p)-Pd(p);
Qspe(p)=Qg(p)-Qd(p);
delP(p)=Pspe(p)-P(p);
delQ(p)=Qspe(p)-Q(p);
end
end
P;
Q;
Pspe;
Qspe;
delP;
delQ;
%Calculation of J1
P2=[0 0 0];
for p=2:nb
for q=2:nb
if(p==q)
P1=2*v(p)*Ybusmag(p,q)*cos(angle(Ybus(p,q)));
for j=1:nb
if (j~=p)
P2(q)=P2(q)+v(j)*Ybusmag(q,j)*cos(del(q)+angle(Ybus(q,j))-del(j));
PV(p,q)=P1+P2(q);
end
end
else
PV(p,q)=v(p)*Ybusmag(p,q)*cos(del(p)+angle(Ybus(p,q))-del(q));
end
end
end
PV;
% Calculation of J2
Pdel=[0 0 0;0 0 0;0 0 0];
for p=2:nb
for q=2:nb
if(p==q)
for j=1:nb
if(j~=p)
Pdel(p,q)=Pdel(p,q)-v(j)*v(q)*Ybusmag(q,j)*sin(del(q)-angle(Ybus(p,j))-del(j));
end
end
else
Pdel(p,q)=-v(p)*v(q)*Ybusmag(p,q)*sin(del(p)+angle(Ybus(p,q))-del(q));
end
end
end
Pdel;
%Calculation of J3
Q2=[0 0 0];
for p=2:nb
for q=2:nb
if(p==q)
Q1=2*v(p)*Ybusmag(p,q)*sin(-angle(Ybus(p,q)));
for j=1:nb
if (j~=p)
Q2(q)=Q2(q)+v(j)*Ybusmag(q,j)*sin(del(q)-angle(Ybus(q,j))-del(j));
QV(p,q)=Q1+Q2(q);
end
end
else
QV(p,q)=v(p)*Ybusmag(p,q)*sin(del(p)-angle(Ybus(p,q))-del(q));
end
end
end
QV;
%Calculation of J4
Qdel=[0 0 0;0 0 0;0 0 0];
for p=2:nb
for q=2:nb
if(p==q)
for j=1:nb
if(j~=p)
Qdel(p,q)=Qdel(p,q)+v(j)*v(q)*Ybusmag(q,j)*cos(del(q)+angle(Ybus(p,j))-del(j));
end
end
else
Qdel(p,q)=-v(p)*v(q)*Ybusmag(p,q)*cos(del(p)+angle(Ybus(p,q))-del(q));
end
end
end
Qdel;
%Jacobian matrix
PV(1,:)=[ ];
PV(:,1)=[ ];
Pdel(1,:)=[ ];
Pdel(:,1)=[ ];
QV(1,:)=[ ];
QV(:,1)=[ ];
Qdel(1,:)=[ ];
Qdel(:,1)=[ ];
J=[PV Pdel;QVQdel]
%Find the change in v&del
delP(1:1)=[];
delQ(1:1)=[];
delpq=[delP';delQ']
vdel=inv(J)*delpq
%Find new v&del
fori=1:nb-1
for j=2:nb
vnew(i)=v(j)+vdel(i);
delnew(i)=del(j)+vdel(i+2);
end
end
VNEW=[v(1) vnew]
DELNEW=[del(1) delnew]
OUTPUT
Ybus =
J=
2.8420 -1.6670 8.9750 -5.0000
-1.6670 6.3670 -5.0000 20.9000
8.5250 -5.0000 -2.9920 1.6670
-5.0000 19.1000 1.6670 -6.9670
delpq =
0.2750
-0.3000
0.2250
0.6500
vdel =
0.0575
0.0410
0.0088
-0.0201
VNEW =
DELNEW =
0 0.0088 -0.0201
RESULT
Thus the power flow for the given problem was solved using Newton Raphson method
and verified using MATLAB software.
Ex.No :
Date :
LOAD FLOW ANALYSIS USING FAST DECOUPLED METHOD
AIM
To determine the Power flow analysis by Fast Decoupled Method
ALGORITHM
Step 1. Form the Ybus Matrix
Step 2. Assume flat start for starting voltage
δi0 = 0 for i=1-n(for all buses except slack bus)
|Vi|=1.0 for i=1…n (For all PQ Bus)
|Vi| = |Vi|spec (for PV bus and slack bus)
Step 3. For load buses, calculate Pical and Qical using
n
Pical = ∑ |V i||Y ij||V j|cos ¿δj - δi)
j=1
n
Qical = ∑ |V i||Y ij||V j|sin ¿δj - δi)
j=1
PROGRAM:
%Fast decoupled power flow method
clc
clear all
y11 = 0.0839+0.5183j;
hlc = 0.0636*j;
disp('STEP 1: Form Y-Bus matrix') Y11 = (1/y11)+hlc;
Y12 = -(1/y11); Y21 = -(1/y11);
Y22 = (1/y11)+hlc;
ybus= [Y11 Y12; Y21 Y22]
Y11m = abs(Y11);
Y12m = abs(Y12);
Y21m = abs(Y21);
Y22m = abs(Y22);
Y11a = angle(Y11);
Y12a = angle(Y12);
Y21a = angle(Y21);
Y22a = angle(Y22);
disp('STEP 2: Initialize bus voltages')
v1 = 1.05
v2 = 1.02
d1 = 0
d2 = 0
disp('STEP 3: Check for Q-limit violation')
Q2cal = -((v2*v1*Y21m*sin(Y21a-d2+d1))+(v2*v2*Y22m*sin(Y22a))) Q2min = 10/100
Q2spec= 0.1;
disp('Q2cal < Q2min, therefore Q2cal is with in the limit')
disp('Bus 2 act as pv bus')
v2 = 1;
disp('STEP 4: Calculate dP2 and dQ2')
P2cal = ((v2*v1*Y21m*cos(Y21a-d2+d1))+(v2*v2*Y22m*cos(Y22a))) P2spec= 60/100
dP2 = P2spec-P2cal dQ2 = Q2spec-Q2cal
disp('STEP 5: Bus susceptance matrix')
B1 = [-1.817]
B1_inv = inv(B1)
B2 = [-1.817] B2_inv = inv(B1)
disp('STEP 6: calculate d2new and V2new')
del = -B1_inv*(dP2/v2);
d2new = d2+del
dV2 = -B2_inv*(dQ2/v2);
V2new = v2+dV2
OUTPUT:
v1 = 1.0500
v2 = 1.0200
d1 = 0
d2 = 0
Q2cal = -0.1237
Q2min = 0.1000
Q2cal < Q2min, therefore Q2cal is with in the limitBus 2 act as pv bus
P2cal = -0.0152
P2spec = 0.6000
dP2 = 0.6152
dQ2 = 0.2237
B1 = -1.8170
B1_inv = -0.5504
B2 = -1.8170
B2_inv = -0.5504
d2new = 0.3386
V2new = 1.1231
RESULT:
Thus the performance of load flow analysis using Fast Decoupled method is obtained with the
help of Matlab program and output is verified.
Ex. No :
Date :
SYMMETRICAL FAULT ANALYSIS
AIM
SOFTWARE REQUIRED
MATLAB 7.6
FORMULAE:
Fault current,If=V/(Zf+Zpp)
Fault voltage Vf =V(1-(Zbus/(Zf+Zpp))
Where Zf=Fault impedance
Zpp= Line impedance
ALGORITHM
Step1: Read line data,machine data, transformer data, fault impedance etc.
Step2: Form the admittance[Ybus] matrix and calculate [Ybus]modi.
Step3:Form [Zbus] by inverting the[Ybus] modified.
Step4:Initialize count I=0..
Step5: Find the bus at which fault occurs I=I+1.
Step6: Compute fault current at faulted bus and bus voltage at all buses..
Step7: Compute all line and generator currents.
Step8:Check if I<number of buses, if yes go to step 5 else go to step 9.
Step9:Print the results and stop the program.
EXERCISE:
For the given network determine the fault current when fault occurs at bus no.1 also
determine the voltage at all the buses and all line currents.
PROGRAM:
disp('symmetrical fault analysis')
nb=input('enter the no. of buses')
nl=input('enter the no.of lines')
sb=input('enter the starting bus number')
eb=input('enter the ending bus number')
linez=input('enter the line impedance')
fori=1:nb
y(i,i)=0;
z(i,i)=0;
end
%formation of ybus matrix
fori=1:nl
r1=sb(i);
r2=eb(i);
y(r1,r1)=y(r1,r1)+(1/linez(i));
y(r2,r2)=y(r2,r2)+(1/linez(i));
y(r1,r2)=-(1/linez(i));
y(r2,r1)=y(r1,r2);
end
G(1)=input('enter generator 1 impedance value')
G(2)=input('enter generator 2 impedance value')
T(1)=input('enter Transformer 1 impedance value')
T(2)=input('enter Transformer 2 impedance value')
y(1,1)=(1/(G(1)+T(1)))+y(1,1)
y(3,3)=(1/(G(2)+T(2)))+y(3,3)
y
disp('formation of zbus matrix')
z=inv(y)
%Espec-Specified voltage
Espec(1)=complex(1,0);
%zf-Fault impedance
zf=0;i=1;
%If-fault current
If=(Espec(1))/(z(i,i)+zf)
OUTPUT:
symmetrical fault analysis
enter the no. of buses3
nb = 3
enter the no.of lines4
nl = 4
enter the starting bus number[1 1 2 1]
sb =
1 1 2 1
enter the ending bus number[2 2 3 3]
eb =
2 2 3 3
enter the line impedance[0.05i 0.05i 0.06i 0.1i]
linez =
0 + 0.0500i 0 + 0.0500i 0 + 0.0600i 0 + 0.1000i
enter generator 1 impedance value0.25i
G=
0 + 0.2500i 0 + 0.2000i
enter generator 2 impedance value0.2i
G=
0 + 0.2500i 0 + 0.2000i
enter Transformer 1 impedance value0.1i
T=
0 + 0.1000i 0 + 0.0200i
enter Transformer 2 impedance value0.08i
T=
0 + 0.1000i 0 + 0.0800i
y=
0 -52.8571i 0 +20.0000i 0 +10.0000i
0 +20.0000i 0 -56.6667i 0 +16.6667i
0 +10.0000i 0 +16.6667i 0 -26.6667i
y=
0 -52.8571i 0 +20.0000i 0 +10.0000i
0 +20.0000i 0 -56.6667i 0 +16.6667i
0 +10.0000i 0 +16.6667i 0 -30.2381i
y=
0 -52.8571i 0 +20.0000i 0 +10.0000i
0 +20.0000i 0 -56.6667i 0 +16.6667i
0 +10.0000i 0 +16.6667i 0 -30.2381i
Ex.No :
Date :
TRANSIENT AND SMALL SIGNAL STABILITY ANALYSIS – SINGLE MACHINE
AIM
To become familiar with various aspects of the transient and small signal stability
analysis of Single-Machine-Infinite Bus (SMIB) system
SOFTWARE REQUIRED
MATLAB 7.6
FORMULA
Reactive power Qe = sin(cos-1(p.f))
S*
Stator Current It =
Et*
Pe - jQe
=
Et*
Prefault Operation:
X1 X2
X = j Xd1+ jXtr +
X1 + X2
E1 x EB
Power Pe = sino
X
Pe* X
o = sin-1
E1 * EB
During Fault Condition:
Pe= PEii = 0
E1 x EB
Power Pe = sino
X
max = - o
P3max - P2max
2H (cr- o)
tcr=
fo Pm Secs
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 pressing Tools – Run
5. View the results.
PROGRAM
RESULT
AIM
To become familiar with various aspects of the transient stability analysis of Multi
-Machine-Infinite Bus (SMIB) system
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 pressing Tools – Run
5. View the results.
PROGRAM:
%program for MMIB
x1=(1.04+((0.608*0.27)/1.04)+(i*(0.608*0.716)/1.04));
x2=(1.025+((0.1198*0.067)/1.025)+(i*(0.1198*1.63)/1.025));
A=(((0.1813)*(-1.109))/1.025);
x3=(1.025+(A))+(i*(0.1813*0.850)/1.025);
e1=abs(x1);
e2=abs(x2);
e3=abs(x3);
t1=angle(x1);
t2=angle(x2);
t3=angle(x3);
m1=pi*60/23.64;
m2=pi*60/6.4;
m3=pi*60/3.01;
T1=t1+0;
T2=t2+(9.3*pi/180);
T3=t3+(4.7*pi/180);
Y=[0.845-2988i 0.287+1.513i 0.21+1.226i;
0.287+1.513i 0.42-2.724i 0.21+1.226i;
0.21+1.226i 0.213+1.088i 0.277-2.368i];
z=angle(Y);
y=abs(Y);
b1=(m1*e1*e2*y(1,2)*sin(T1-T2-z(1,2)))+(m1*e1*e3*y(1,3)*sin(T1-T3-z(1,3)))+
(m3*e1*e3*y(1,3)*sin(T3-T1-z(1,3)));
b4=(m2*e1*e2*y(1,2)*sin(T2-T1-z(1,2)))+(m2*e2*e3*y(2,3)*sin(T2-T3-z(2,3)))+
(m3*e2*e3*y(2,3)*sin(T3-T2-z(2,3)));
b2=(-m1*e1*e2*y(1,2)*sin(T1-T2-z(1,2)))+(m3*e2*e3*y(2,3)*sin(T3-T2-z(2,3)));
b3=(-m1*e1*e2*y(1,2)*sin(T2-T1-z(1,2)))+(m3*e1*e3*y(1,3)*sin(T3-T1-z(1,3)));
A=[0 b1 0 b2;1 0 0 0;0 b3 0 b4 ;0 0 1 0] %state space matrix
%A=[0 0 1 0; 0 0 0 1 ;b1 b3 0 0;b2 b4 0 0];
%A=[0 0 1 0; 0 0 0 1;-104.1 -59.52 0 0 ; -33.84 -153.46 0 0];
%v is right eigen vector
E=eig(A) %v right eigen vector
[v,c]=eig(A); %v right eigen vector
[w,f]=eig(A');
d=w'; %d is the left eigen vector
U=[v(1,1)*d(1,1) v(1,2)*d(2,1) v(1,3)*d(3,1) v(1,4)*d(4,1);
v(2,1)*d(1,2) v(2,2)*d(2,2) v(2,3)*d(3,2) v(2,4)*d(4,2);
v(3,1)*d(1,3) v(3,2)*d(2,3) v(3,3)*d(3,3) v(3,4)*d(4,3);
v(4,1)*d(1,4) v(4,2)*d(2,4) v(4,3)*d(3,4) v(4,4)*d(4,4)];
P=abs(U) %PARTICIPTION FACTOR
OUTPUT:
A=
0 -109.2716 0 -52.5534
1.0000 0 0 0
0 -66.8326 0 -159.3219
0 0 1.0000 0
E=
0.0000 + 8.3645i
0.0000 - 8.3645i
-0.0000 +14.0936i
-0.0000 -14.0936i
P=
0.0337 0.0337 0.0517 0.0517
0.0568 0.0568 0.0307 0.0307
0.0337 0.0337 0.0517 0.0517
0.0568 0.0568 0.0307 0.0307
RESULT
Transient stability analysis of Multi-Machine-Infinite Bus (SMIB) system was studied
and simulated using simulation software.
Ex.No :
Date :
ELECTROMAGNETIC TRANSIENTS IN POWER SYSTEMS
AIM
To study and understand the electromagnetic transient phenomena in power system
caused due to switching & faults electromagnetic transients program using MATLAB
SOFTWARE REQUIRED
MATLAB 7.6
FORMULA USED:
Case (i):
REACTIVE TERMINATION: LINE TERMINATED BY INDUCTOR:
et = 2ef
er= e r=-if
PROGRAM:
OUTPUT:
OUTPUT
RESULT:
Thus the electromagnetic transients in power system have been studied using matlab.
Ex. No:
Date :
LOAD FREQUENCY CONTROL OF SINGLE AREA SYSTEM
AIM
To simulate the transient analysis of the load control modes single area without PI
controller and single area with PI controller.
SOFTWARE REQUIRED:
Matlab 7.6
Primary control
The speed change from synchronous speed initiates the governor control action resulting
in all the participating generator turbine units taking up the chance in load and satellite the
system frequency.
Secondary control
It adjusts the load reference set point of selected turbine generator units so as to gain normal
value of frequency. An isolated power station has the following terms
Turbine time constant TT=0.5 sec
Governor time constant Tg= 0.2 sec
Governor inter constant H= 5 sec
Governor speed regulation = 2 per unit
DPL =0.2
PROCEDURE
1. Enter the command window of the MATLAB.
2. Create a new model by selecting file model.
3. Pick up the block from Simulink library browser and form the block diagram.
4. Double click the scope and view the result
SIMULINK DIAGRAM
WITHOUT INTEGRATOR
OUTPUT:
WITH INTEGRATOR
OUTPUT
RESULT
The load control of a single area power system with and without frequency controller is
obtained.
Ex.No :
Date :
LOAD FREQUENCY DYNAMICS OF TWO AREA SYSTEM
AIM
To become familiar with modeling and analysis of the frequency and time flow dynamics
of a two area power system without and with load frequency controller and to design better
controllers for getting better response.
SOFTWARE REQUIRED
Matlab 7.6
PROCEDURE
1. Enter the command window of the MATLAB.
2. Create a new model by selecting file model.
3. Pick up the block from Simulink library browser and form the block diagram.
4. Double click the scope and view the result
OUTPUT:
RESULT
The load control of a single area power system with and without frequency controller is
obtained.
Ex.No :
Date :
ECONOMIC DISPATCH IN POWER SYSTEM
AIM
To determine the economic scheduling of generators and estimate the full load
averages cost and verify using MATLAB software.
SOFTWARE REQUIRED
Matlab software
ALGORITHM
Step 4: Find the new PGifor remaining generators which are not fixed as
PD(new) =PD(old) – (sum of fixed generators)
Step 5:Calculate λ and PGias above for the remaining generators till the limits satisfied
Step 6:Find the cost function of each generator and total cost as
F(i)=aiPGi2 + biPGi + ci
Step 7:Stop the program
EXERCISE:
1. The fuel cost functions for three thermal plants in $/h are given by
C1 = 500 + 5.3 P1 + 0.004 P12; P1 in MW
C2 = 400 + 5.5 P2 + 0.006 P22; P2 in MW
C3 = 200 +5.8 P3 + 0.009 P32; 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:
clc;
clearall;
warningoff;
a=[.004; .006; .009];
b=[5.3; 5.5; 5.8];
c=[500; 400; 200];
Pd=800;
delp=10;
lambda=input('Enter estimated value of lambda=');
fprintf('\n')
disp(['lambda P1 P1 P3 delta p delta lambda'])
iter=0;
while abs(delp)>=0.001
iter=iter+1;
p=(lambda-b)./(2*a);
delp=Pd-sum(p);
J=sum(ones(length(a),1)./(2*a));
dellambda=delp/J;
disp([lambda,p(1),p(2),p(3),delp,dellambda])
lambda=lambda+dellambda;
end
lambda
p
totalcost=sum(c+b.*p+a.*p.^2)
OUTPUT
Enter estimated value of lambda= 10
lambda =
8.5000
p=
400.0000
250.0000
150.0000
totalcost = 6.6825e+003
EXERCISE:
2. The fuel cost functions for three thermal plants in $/h are given by
C1 = 500 + 5.3 P1 + 0.004 P12; P1 in MW
C2 = 400 + 5.5 P2 + 0.006 P22 ; P2 in MW
C3 = 200 + 5.8 P3 + 0.009 P32; P3 in MW
The total load , PD is 975MW. Generation limits
200 P1 450 MW
150 P2 350 MW
100 P3 225 MW
Find the optimal dispatch and the total cost in $/h by analytical method. Verify the result using
MATLAB program.
PROGRAM
clear
clc
n=3;
demand=925;
a=[.0056 .0045 .0079];
b=[4.5 5.2 5.8];
c=[640 580 820];
Pmin=[200 250 125];
Pmax=[350 450 225];
x=0; y=0;
fori=1:n
x=x+(b(i)/(2*a(i)));
y=y+(1/(2*a(i)));
lambda=(demand+x)/y
Pgtotal=0;
fori=1:n
Pg(i)=(lambda-b(i))/(2*a(i));
Pgtotal=sum(Pg);
end
Pg
fori=1:n
if(Pmin(i)<=Pg(i)&&Pg(i)<=Pmax(i));
Pg(i);
else
if(Pg(i)<=Pmin(i))
Pg(i)=Pmin(i);
else
Pg(i)=Pmax(i);
end
end
Pgtotal=sum(Pg);
end
Pg
ifPgtotal~=demand
demandnew=demand-Pg(1)
x1=0;
y1=0;
fori=2:n
x1=x1+(b(i)/(2*a(i)));
y1=y1+(1/(2*a(i)));
end
lambdanew=(demandnew+x1)/y1
fori=2:n
Pg(i)=(lambdanew-b(i))/(2*a(i));
end
end
end
Pg
OUTPUT
Lamb da =
8.6149
Pg =
Demand new =
575
Lambda new =
8.7147
Pg =
RESULT:
Economic load dispatch for the given problem was solved using classical method with
and without line losses and verified using MATLAB software.