Prepared By Prof. Dr Atef El-Emary

Size: px
Start display at page:

Download "Prepared By Prof. Dr Atef El-Emary"

Transcription

1 JAZAN UNIVERSITY COLLEGE OF ENGINEERING Electrical Engineering Department Experimental Lab of EngE 511 Electrical Power System 2 Prepared By Prof. Dr Atef El-Emary

2 Contents 1) Admittance matrix formation by inspection 2) Load flow using Gauss-Seidel method based on P-Q bus 3) Load flow using Gauss-Seidel method based on P-V bus 4) Load flow using Newton-Raphson method based on P-V bus 5) Fast Decoupled load flow based on P-V bus 6) Steady State stability-1 7) Steady State stability-2 8) Transient stability -1 9) Transient stability -2

3 Lab1 Formation of YBUS By inspection The one line diagram of a simple three bus power system is shown in figure with generation at bus 1. The magnitude of voltage at bus 1 is adjusted to 1.05 pu. The scheduled loads at buses 2 and 3 are as marked on the diagram. Line impedances are marked on a 100 MVA base and the line charging susceptances are neglected. Construct the bus admittance matrix

4 % Forming Bus Admittance Matrix % Line code % Bus bus R X 1/2 B = 1 for lines % nl nr p.u. p.u. p.u. > 1 or < 1 tr. tap at bus nl linedata=[ ]; nl=linedata(:,1); nr=linedata(:,2); R=linedata(:,3); X=linedata(:,4); nbr=length(linedata(:,1)); nbus = max(max(nl), max(nr)); Z = R + j*x; %branch impedance y= ones(nbr,1)./z %branch admittance Ybus=zeros(nbus,nbus); % initialize Ybus to zero for k = 1:nbr; % formation of the off diagonal elements if nl(k) > 0 & nr(k) > 0 Ybus(nl(k),nr(k)) = Ybus(nl(k),nr(k)) - y(k); Ybus(nr(k),nl(k)) = Ybus(nl(k),nr(k)); end end for n = 1:nbus for k = 1:nbr if nl(k) == n nr(k) == n Ybus(n,n) = Ybus(n,n) + y(k); else, end end end fprintf(' admittance matrix\n') for n5 = 1:nbus for n6 = 1:nbus % formation of the diagonal elements fprintf('%9.3f',real(ybus(n5,n6))),fprintf('%9.3f',imag(y bus(n5,n6))) end end c=ybus

5 Lab 2 Load Flow by Gauss Seidel Method The one line diagram of a simple three bus power system is shown in figure with generation at bus 1. The magnitude of voltage at bus 1 is adjusted to 1.05 pu. The scheduled loads at buses 2 and 3 are as marked on the diagram. Line impedances are marked on a 100 MVA base and the line charging susceptances are neglected. Required: a) Using the Gauss-Seidel method, the phasor values of the voltage at the load buses 2 and 3 (P-Q buses) accurate to four decimal places. b) Find the slack bus real and reactive power c) Determine the line flows and line losses. Construct a power flow diagram showing the direction of line flow

6 % LF P-Q Buses % Lab 2 y12=10-j*20; y13=10-j*30; y23=16-j*32; V1=1.05+j*0; iter =0; S2= j*1.102; S3= j*.452; V2=1+j*0; V3=1+j*0; for I=1:10 iter=iter+1; V2 = (conj(s2)/conj(v2)+y12*v1+y23*v3)/(y12+y23); V3 = (conj(s3)/conj(v3)+y13*v1+y23*v2)/(y13+y23); disp([iter, V2, V3]) end V2=.98-j*.06; V3= 1-j*.05; I12=y12*(V1-V2); I21=-I12; I13=y13*(V1-V3); I31=-I13; I23=y23*(V2-V3); I32=-I23; S12=V1*conj(I12); S21=V2*conj(I21); S13=V1*conj(I13); S31=V3*conj(I31); S23=V2*conj(I23); S32=V3*conj(I32); I1221=[I12,I21] I1331=[I13,I31] I2332=[I23,I32] S1221=[S12, S21 (S12+S13) S12+S21] S1331=[S13, S31 (S31+S32) S13+S31] S2332=[S23, S32 (S23+S21) S23+S32]

7 Lab4 Load Flow by Newton Raphson Method (Voltage Controlled) The one line diagram of a simple three bus power system is shown in figure with generators at bus 1 and 3. The magnitude of voltage at bus 1 is adjusted to 1.05 pu. Voltage magnitude at bus 3 is fixed at 1.04 pu with a real power generation of 200 MW. A load consisting of 400 MW and 250 Mvar is taken from bus 2. Line impedances are marked in per unit on a 100MVA base, and the line charging susceptances are neglected. Obtain the power flow solution by Newton Raphson method including line flows and line losses.

8 % Lab 4 % Newton-Raphson method LF Voltage controlled V = [1.05; 1.0; 1.04]; d = [0; 0; 0]; Ps=[-4; 2.0]; Qs= -2.5; YB = [ 20-j*50-10+j*20-10+j*30-10+j*20 26-j*52-16+j*32-10+j*30-16+j*32 26-j*62]; Y= abs(yb); t = angle(yb); iter=0; pwracur = ; % Power accuracy DC = 10; % Set the maximum power residual to a high value while max(abs(dc)) > pwracur iter = iter +1 P=[V(2)*V(1)*Y(2,1)*cos(t(2,1)- d(2)+d(1))+v(2)^2*y(2,2)*cos(t(2,2))+... V(2)*V(3)*Y(2,3)*cos(t(2,3)-d(2)+d(3)); V(3)*V(1)*Y(3,1)*cos(t(3,1)- d(3)+d(1))+v(3)^2*y(3,3)*cos(t(3,3))+... V(3)*V(2)*Y(3,2)*cos(t(3,2)-d(3)+d(2))]; Q= -V(2)*V(1)*Y(2,1)*sin(t(2,1)-d(2)+d(1))- V(2)^2*Y(2,2)*sin(t(2,2))-... V(2)*V(3)*Y(2,3)*sin(t(2,3)-d(2)+d(3)); J(1,1)=V(2)*V(1)*Y(2,1)*sin(t(2,1)-d(2)+d(1))+... V(2)*V(3)*Y(2,3)*sin(t(2,3)-d(2)+d(3)); J(1,2)=-V(2)*V(3)*Y(2,3)*sin(t(2,3)-d(2)+d(3)); J(1,3)=V(1)*Y(2,1)*cos(t(2,1)- d(2)+d(1))+2*v(2)*y(2,2)*cos(t(2,2))+... V(3)*Y(2,3)*cos(t(2,3)-d(2)+d(3)); J(2,1)=-V(3)*V(2)*Y(3,2)*sin(t(3,2)-d(3)+d(2)); J(2,2)=V(3)*V(1)*Y(3,1)*sin(t(3,1)-d(3)+d(1))+... V(3)*V(2)*Y(3,2)*sin(t(3,2)-d(3)+d(2)); J(2,3)=V(3)*Y(2,3)*cos(t(3,2)-d(3)+d(2)); J(3,1)=V(2)*V(1)*Y(2,1)*cos(t(2,1)-d(2)+d(1))+... V(2)*V(3)*Y(2,3)*cos(t(2,3)-d(2)+d(3)); J(3,2)=-V(2)*V(3)*Y(2,3)*cos(t(2,3)-d(2)+d(3)); J(3,3)=-V(1)*Y(2,1)*sin(t(2,1)-d(2)+d(1))- 2*V(2)*Y(2,2)*sin(t(2,2))-... V(3)*Y(2,3)*sin(t(2,3)-d(2)+d(3)); DP = Ps - P; DQ = Qs - Q; DC = [DP; DQ] J DX = J\DC d(2) =d(2)+dx(1);

9 d(3)=d(3) +DX(2); V(2)= V(2)+DX(3); V, d, delta =180/pi*d; end P1=V(1)^2*Y(1,1)*cos(t(1,1))+V(1)*V(2)*Y(1,2)*cos(t(1,2)- d(1)+d(2))+ V(1)*V(3)*Y(1,3)*cos(t(1,3)-d(1)+d(3)) Q1=-V(1)^2*Y(1,1)*sin(t(1,1))- V(1)*V(2)*Y(1,2)*sin(t(1,2)-d(1)+d(2))- V(1)*V(3)*Y(1,3)*sin(t(1,3)-d(1)+d(3)) Q3=-V(3)*V(1)*Y(3,1)*sin(t(3,1)-d(3)+d(1))- V(3)*V(2)*Y(3,2)*... sin(t(3,2)-d(3)+d(2))-v(3)^2*y(3,3)*sin(t(3,3))

10 Lab 5 Fast Decoupled Load Flow (Voltage Controlled) The one line diagram of a simple three bus power system is shown in figure with generators at bus 1 and 3. The magnitude of voltage at bus 1 is adjusted to 1.05 pu. Voltage magnitude at bus 3 is fixed at 1.04 pu with a real power generation of 200 MW. A load consisting of 400 MW and 250 Mvar is taken from bus 2. Line impedances are marked in per unit on a 100MVA base, and the line charging susceptances are neglected. Obtain the power flow solution by Fast Decoupled load Flow method including line flows and line losses.

11 % Lab 5 % Fast decoupled method, Voltage Controlled V1= 1.05; V2 = 1.0; V3 = 1.04; d1 = 0; d2 = 0; d3=0; Ps2=-4; Ps3 =2.0; Qs2= -2.5; YB = [ 20-j*50-10+j*20-10+j*30-10+j*20 26-j*52-16+j*32-10+j*30-16+j*32 26-j*62]; Y = abs(yb); t=angle(yb); B =[-52 32; 32-62] Binv = inv(b) iter=0; pwracur = ; % Power accuracy DC = 10; % Set the max of power mismatch to a high value while max(abs(dc)) > pwracur iter = iter +1; P2= V2*V1*Y(2,1)*cos(t(2,1)-d2+d1)+V2^2*Y(2,2)*cos(t(2,2))+... V2*V3*Y(2,3)*cos(t(2,3)-d2+d3); P3= V3*V1*Y(3,1)*cos(t(3,1)-d3+d1)+V3^2*Y(3,3)*cos(t(3,3))+... V3*V2*Y(3,2)*cos(t(3,2)-d3+d2); Q2=-V2*V1*Y(2,1)*sin(t(2,1)-d2+d1)-V2^2*Y(2,2)*sin(t(2,2))-... V2*V3*Y(2,3)*sin(t(2,3)-d2+d3); DP2 = Ps2 - P2; DP2V = DP2/V2; DP3 = Ps3 - P3; DP3V = DP3/V3; DQ2 = Qs2 - Q2; DQ2V = DQ2/V2; DC =[DP2; DP3; DQ2]; Dd = -Binv*[DP2V;DP3V]; DV = -1/B(1,1)*DQ2V; d2 =d2+dd(1); d3 =d3+dd(2); V2= V2+DV; angle2 =180/pi*d2; angle3 =180/pi*d3; R = [iter d2 d3 V2 DP2 DP3 DQ2]; disp(r) end Q3=-V3*V1*Y(3,1)*sin(t(3,1)-d3+d1)-V3^2*Y(3,3)*sin(t(3,3))-... V3*V2*Y(3,2)*sin(t(3,2)-d3+d2); P1= V1^2*Y(1,1)*cos(t(1,1))+V1*V2*Y(1,2)*cos(t(1,2)-d1+d2)+... V1*V3*Y(1,3)*cos(t(1,3)-d1+d3); Q1=-V1^2*Y(1,1)*sin(t(1,1))-V1*V2*Y(1,2)*sin(t(1,2)-d1+d2)-... V1*V3*Y(1,3)*sin(t(1,3)-d1+d3); S1=P1+j*Q1 Q3

12 Lab 3 Load flow using Gauss-Seidel based on voltage controlled bus The one line diagram of a simple three bus power system is shown in figure with generators at bus 1 and 3. The magnitude of voltage at bus 1 is adjusted to 1.05 pu. Voltage magnitude at bus 3 is fixed at 1.04 pu with a real power generation of 200 MW. A load consisting of 400 MW and 250 Mvar is taken from bus 2. Line impedances are marked in per unit on a 100MVA base, and the line charging susceptances are neglected. Obtain the power flow solution by the Gauss- Seidel method including line flows and line losses.

13 % Lab 3 %LF Voltage control y12=10-j*20; y13=10-j*30; y23=16-j*32; y33=y13+y23; V1=1.05+j*0; format long iter =0; S2=-4.0-j*2.5; P3 = 2; V2=1+j*0; Vm3=1.04; V3=1.04+j*0; for I=1:10; iter=iter+1 E2 = V2; E3=V3; V2 = (conj(s2)/conj(v2)+y12*v1+y23*v3)/(y12+y23) DV2 = V2-E2 Q3 = -imag(conj(v3)*(y33*v3-y13*v1-y23*v2)) S3 = P3 +j*q3; Vc3 = (conj(s3)/conj(v3)+y13*v1+y23*v2)/(y13+y23) Vi3 = imag(vc3); Vr3= sqrt(vm3^2 - Vi3^2); V3 = Vr3 + j*vi3 DV3=V3-E3 end format short I12=y12*(V1-V2); I21=-I12; I13=y13*(V1-V3); I31=-I13; I23=y23*(V2-V3); I32=-I23; S12=V1*conj(I12); S21=V2*conj(I21); S13=V1*conj(I13); S31=V3*conj(I31); S23=V2*conj(I23); S32=V3*conj(I32); I1221=[I12,I21] I1331=[I13,I31] I2332=[I23,I32] S1221=[S12, S21 (S12+S13) S12+S21] S1331=[S13, S31 (S31+S32) S13+S31] S2332=[S23, S32 (S23+S21) S23+S32]

14 Lab 6 Steady State Stability A 60 c/s synchronous generator having inertia constant H = 9.94 MJ/MVA and a \ transient reactance X d = 0.3 pu is connected to an infinite bus through a purely reactive circuit as shown in figure below. Reactances are marked on the diagram on a common system base. The generator is delivering real power of 0.6 pu, 0.8 power factor lagging to the infinite bus at a voltage of V = 1 pu. Assume the per unit damping power coefficient is D = 0.138, consider a small disturbance of Δδ = 10 o = radian. For example, the breakers open and then quickly close. Obtain equations describing the motion of the rotor angle and the generator frequency.

15 % Lab 6 E = 1.35, V= 1.0; H= 9.94; X=0.65; Pm=0.6; D=0.138; f0 = 60; Pmax = E*V/X, d0 = asin(pm/pmax) % Max. power Ps = Pmax*cos(d0) % Synchronizing power coefficient wn = sqrt(pi*60/h*ps) % Undamped frequency of oscillation z = D/2*sqrt(pi*60/(H*Ps)) % Damping ratio wd = wn*sqrt(1-z^2), fd = wd/(2*pi) %Damped frequency oscill. tau = 1/(z*wn) % Time constant th = acos(z) % Phase angle theta Dd0 = 10*pi/180; % Initial angle in radian t = 0:.01:3; Dd = Dd0/sqrt(1-z^2)*exp(-z*wn*t).*sin(wd*t + th); d = (d0+dd)*180/pi; % Load angle in degree Dw = -wn*dd0/sqrt(1-z^2)*exp(-z*wn*t).*sin(wd*t); f = f0 + Dw/(2*pi); % Frequency in Hz figure(1), subplot(2,1,1), plot(t, d), grid xlabel('t, sec'), ylabel('delta, degree') subplot(2,1,2), plot(t,f), grid xlabel('t, sec'), ylabel('f, Hz') subplot(111) % using initial function state space equation A = [0 1; -wn^2-2*z*wn]; % wn, z and t are defined earlier Dp=0.2; du= 3.79; % small step change in power input B = [0; 0]; % Column B zero-input C = [1 0; 0 1]; % Unity matrix defining output y as x1 and x2 D = [0; 0]; Dx0 = [Dd0; 0]; % Zero initial cond., Dd0 is defined earlier [y,x]= initial(a, B, C, D, Dx0, t); Dd = x(:, 1); Dw = x(:, 2); % State variables x1 and x2 d = (d0 + Dd)*180/pi; % Load angle in degree f = f0 + Dw/(2*pi); % Frequency in Hz figure(2), subplot(2,1,1), plot(t, d), grid xlabel('t, sec'), ylabel('delta, degree') subplot(2,1,2), plot(t, f), grid xlabel('t, sec'), ylabel('f, Hz'), subplot(111)

16 Lab 7 Steady State stability The generator of lab 6 is operating in the steady state at δ o = o when the input power is increased by a small amount ΔP = 0.2 pu. The generator excitation and the infinite bus bar voltage are E ' = 1.35 pu and V= 1.0 pu. a) Obtain the step response for the rotor angle and the generator frequency b) Obtain the response using MATLAB step function c) Obtain a SIMULINK block diagram representation of the state space model and simulate to obtain the response.

17 %Lab 7 %(a) Fault at the sending end. Both lines intact when fault is cleared Pm = 0.8; E= 1.17; V = 1.0; X1 = 0.65; X2 = inf; X3 = 0.65; eacfault(pm, E, V, X1, X2, X3) %(b) Fault at the mid-point of one line. Faulted line is isolated X2 = 1.8; X3 = 0.8; eacfault(pm, E, V, X1, X2, X3) function eacfault(pm, E, V, X1, X2, X3) % This program obtains the power angle curves for a one-machine system % before fault, during fault and after the fault clearance. % The equal area criterion is applied to find the critical clearing angle % for the machine to stay synchronized to the infinite bus bar % if exist('pm')~=1 Pm = input('generator output power in p.u. Pm = '); else, end if exist('e')~=1 E = input('generator e.m.f. in p.u. E = '); else, end if exist('v')~=1 V = input('infinite bus-bar voltage in p.u. V = '); else, end if exist('x1')~=1 X1 = input('reactance before Fault in p.u. X1 = '); else, end if exist('x2')~=1 X2 = input('reactance during Fault in p.u. X2 = '); else, end if exist('x3')~=1 X3 = input('reactance aftere Fault in p.u. X3 = '); else, end Pe1max = E*V/X1; Pe2max=E*V/X2; Pe3max=E*V/X3; delta = 0:.01:pi; Pe1 = Pe1max*sin(delta); Pe2 = Pe2max*sin(delta); Pe3 = Pe3max*sin(delta); d0 =asin(pm/pe1max); dmax = pi-asin(pm/pe3max); cosdc = (Pm*(dmax-d0)+Pe3max*cos(dmax)-Pe2max*cos(d0))/(Pe3max-Pe2max); if abs(cosdc) > 1 fprintf('no critical clearing angle could be found.\n') fprintf('system can remain stable during this disturbance.\n\n') return else, end dc=acos(cosdc); if dc > dmax fprintf('no critical clearing angle could be found.\n') fprintf('system can remain stable during this disturbance.\n\n') return else, end Pmx=[0 pi-d0]*180/pi; Pmy=[Pm Pm]; x0=[d0 d0]*180/pi; y0=[0 Pm]; xc=[dc dc]*180/pi; yc=[0 Pe3max*sin(dc)]; xm=[dmax dmax]*180/pi; ym=[0 Pe3max*sin(dmax)];

18 d0=d0*180/pi; dmax=dmax*180/pi; dc=dc*180/pi; x=(d0:.1:dc); y=pe2max*sin(x*pi/180); y1=pe2max*sin(d0*pi/180); y2=pe2max*sin(dc*pi/180); x=[d0 x dc]; y=[pm y Pm]; xx=dc:.1:dmax; h=pe3max*sin(xx*pi/180); xx=[dc xx dmax]; hh=[pm h Pm]; delta=delta*180/pi; if X2 == inf fprintf('\nfor this case tc can be found from analytical formula. \n') H=input('To find tc enter Inertia Constant H, (or 0 to skip) H = '); if H ~= 0 d0r=d0*pi/180; dcr=dc*pi/180; tc = sqrt(2*h*(dcr-d0r)/(pi*60*pm)); else, end else, end %clc fprintf('\ninitial power angle = %7.3f \n', d0) fprintf('maximum angle swing = %7.3f \n', dmax) fprintf('critical clearing angle = %7.3f \n\n', dc) if X2==inf & H~=0 fprintf('critical clearing time = %7.3f sec. \n\n', tc) else, end h = figure; figure(h); fill(x,y,'m') hold; fill(xx,hh,'c') plot(delta, Pe1,'-', delta, Pe2,'r-', delta, Pe3,'g-', Pmx, Pmy,'b-', x0,y0, xc,yc, xm,ym), grid Title('Application of equal area criterion to a critically cleared system') xlabel('power angle, degree'), ylabel(' Power, per unit') text(5, 1.07*Pm, 'Pm') text(50, 1.05*Pe1max,['Critical clearing angle = ',num2str(dc)]) axis([ *Pe1max]) hold off;

19 Simulink of Lab DU=60*pi/(H*0.2) x' = Ax+Bu y = Cx+Du 180/pi Rad to degree delta0 Sum delta Step State-Space 1/(2*pi) rps to HZ 60 frequency Dem ux f0 Sum Simulink Block Diagram with step input disturbance, Lab 7

20 Lab 8 Transient Stability In the system of lab 7 a three phase fault at the middle of one line is cleared by isolating the faulted circuit simultaneously at both ends. a) The fault is cleared in 0.3 second. Obtain the numerical solution of the swing equation for 1.0 second using the modified Euler method with a step size of Δt = 0.01 second. From the swing curve, determine the system stability. b) Repeat part if fault is cleared in 0.5 second. c) Obtain a SIMULINK block diagram model for the swing equation, and simulate for a fault clearing time of 0.3 and 0.5 second. Repeat the simulation until a critical clearing time is obtained.

21 Lab 8 %(a) Fault at the sending end. Both lines intact when fault is cleared Pm = 0.8; E= 1.17; V = 1.0; X1 = 0.65; X2 = inf; X3 = 0.65; eacfault(pm, E, V, X1, X2, X3) %(b) Fault at the mid-point of one line. Faulted line is isolated X2 = 1.8; X3 = 0.8; eacfault(pm, E, V, X1, X2, X3) Simulink of Lab 8 Step pi*60/5 omga dot 1 s Integrator omga 1 s Integrator1 Omga 180/pi Delta Gain1 Rad to degree Switch fault clear *sin(u) Clock During Fault 0.65*sin(u) To change clearing time change tolerance time from switch (Ex: 0.3, 0.4 and 0.5 seconds )

22 Lab 9 Transient Stability Based on 3 Phase Fault A 60 c/s synchronous generator having inertia constant H = 5 MJ/MVA and a direct axis transient reactance X d \ = 0.3 pu is connected to an infinite bus through a purely reactive circuit as shown in figure below. Reactances are marked on the diagram on a common system base. The generator is delivering real power P e = 0.8 pu and Q = pu to the infinite bus as a voltage of V = 1 pu a) A temporary 3 phase fault occurs at the sending of the line at point F. when the fault is cleared, both lines are intact. Determine the critical clearing angle and the critical fault clearing time. b) A 3 phase fault occurs at the middle of one of the lines, the fault is cleared and the faulted line is isolated. Determine the critical clearing angle

23 Lab 9 Pm=0.8; E= 1.17; V= 1.0; X1=0.65; X2=1.8; X3= 0.8 %function eacfault(pm, E, V, X1, X2, X3) % This program obtains the power angle curves for a one-machine system % before fault, during fault and after the fault clearance. % The equal area criterion is applied to find the critical clearing angle % for the machine to stay synchronized to the infinite bus bar % if exist('pm')~=1 Pm = input('generator output power in p.u. Pm = '); else, end if exist('e')~=1 E = input('generator e.m.f. in p.u. E = '); else, end if exist('v')~=1 V = input('infinite bus-bar voltage in p.u. V = '); else, end if exist('x1')~=1 X1 = input('reactance before Fault in p.u. X1 = '); else, end if exist('x2')~=1 X2 = input('reactance during Fault in p.u. X2 = '); else, end if exist('x3')~=1 X3 = input('reactance aftere Fault in p.u. X3 = '); else, end Pe1max = E*V/X1; Pe2max=E*V/X2; Pe3max=E*V/X3; delta = 0:.01:pi; Pe1 = Pe1max*sin(delta); Pe2 = Pe2max*sin(delta); Pe3 = Pe3max*sin(delta); d0 =asin(pm/pe1max); dmax = pi-asin(pm/pe3max); cosdc = (Pm*(dmax-d0)+Pe3max*cos(dmax)-Pe2max*cos(d0))/(Pe3max- Pe2max); if abs(cosdc) > 1 fprintf('no critical clearing angle could be found.\n') fprintf('system can remain stable during this disturbance.\n\n') return else, end dc=acos(cosdc); if dc > dmax fprintf('no critical clearing angle could be found.\n') fprintf('system can remain stable during this disturbance.\n\n') return else, end Pmx=[0 pi-d0]*180/pi; Pmy=[Pm Pm]; x0=[d0 d0]*180/pi; y0=[0 Pm]; xc=[dc dc]*180/pi; yc=[0 Pe3max*sin(dc)]; xm=[dmax dmax]*180/pi; ym=[0 Pe3max*sin(dmax)]; d0=d0*180/pi; dmax=dmax*180/pi; dc=dc*180/pi; x=(d0:.1:dc); y=pe2max*sin(x*pi/180); y1=pe2max*sin(d0*pi/180); y2=pe2max*sin(dc*pi/180); x=[d0 x dc];

24 y=[pm y Pm]; xx=dc:.1:dmax; h=pe3max*sin(xx*pi/180); xx=[dc xx dmax]; hh=[pm h Pm]; delta=delta*180/pi; if X2 == inf fprintf('\nfor this case tc can be found from analytical formula. \n') H=input('To find tc enter Inertia Constant H, (or 0 to skip) H = '); if H ~= 0 d0r=d0*pi/180; dcr=dc*pi/180; tc = sqrt(2*h*(dcr-d0r)/(pi*60*pm)); else, end else, end %clc fprintf('\ninitial power angle = %7.3f \n', d0) fprintf('maximum angle swing = %7.3f \n', dmax) fprintf('critical clearing angle = %7.3f \n\n', dc) if X2==inf & H~=0 fprintf('critical clearing time = %7.3f sec. \n\n', tc) else, end h = figure; figure(h); fill(x,y,'m') hold; fill(xx,hh,'c') plot(delta, Pe1,'-', delta, Pe2,'r-', delta, Pe3,'g-', Pmx, Pmy,'b- ', x0,y0, xc,yc, xm,ym), grid Title('Application of equal area criterion to a critically cleared system') xlabel('power angle, degree'), ylabel(' Power, per unit') text(5, 1.07*Pm, 'Pm') text(50, 1.05*Pe1max,['Critical clearing angle = ',num2str(dc)]) axis([ *Pe1max]) hold off;

B.E. / B.Tech. Degree Examination, April / May 2010 Sixth Semester. Electrical and Electronics Engineering. EE 1352 Power System Analysis

B.E. / B.Tech. Degree Examination, April / May 2010 Sixth Semester. Electrical and Electronics Engineering. EE 1352 Power System Analysis B.E. / B.Tech. Degree Examination, April / May 2010 Sixth Semester Electrical and Electronics Engineering EE 1352 Power System Analysis (Regulation 2008) Time: Three hours Answer all questions Part A (10

More information

INSTITUTE OF AERONAUTICAL ENGINEERING (Autonomous)

INSTITUTE OF AERONAUTICAL ENGINEERING (Autonomous) INSTITUTE OF AERONAUTICAL ENGINEERING (Autonomous) Dundigal, Hyderabad - 500 043 ELECTRICAL AND ELECTRONICS ENGINEERING QUESTION BANK Course Name : Computer Methods in Power Systems Course Code : A60222

More information

KINGS COLLEGE OF ENGINEERING Punalkulam

KINGS COLLEGE OF ENGINEERING Punalkulam KINGS COLLEGE OF ENGINEERING Punalkulam 613 303 DEPARTMENT OF ELECTRICAL AND ELECTRONICS ENGINEERING POWER SYSTEM ANALYSIS QUESTION BANK UNIT I THE POWER SYSTEM AN OVERVIEW AND MODELLING PART A (TWO MARK

More information

EE2351 POWER SYSTEM ANALYSIS UNIT I: INTRODUCTION

EE2351 POWER SYSTEM ANALYSIS UNIT I: INTRODUCTION EE2351 POWER SYSTEM ANALYSIS UNIT I: INTRODUCTION PART: A 1. Define per unit value of an electrical quantity. Write equation for base impedance with respect to 3-phase system. 2. What is bus admittance

More information

QUESTION BANK ENGINEERS ACADEMY. Power Systems Power System Stability 1

QUESTION BANK ENGINEERS ACADEMY. Power Systems Power System Stability 1 ower ystems ower ystem tability QUETION BANK. A cylindrical rotor generator delivers 0.5 pu power in the steady-state to an infinite bus through a transmission line of reactance 0.5 pu. The generator no-load

More information

POWER SYSTEM STABILITY

POWER SYSTEM STABILITY LESSON SUMMARY-1:- POWER SYSTEM STABILITY 1. Introduction 2. Classification of Power System Stability 3. Dynamic Equation of Synchronous Machine Power system stability involves the study of the dynamics

More information

Effect of Inertia Constant on Generator Frequency and Rotor Angle

Effect of Inertia Constant on Generator Frequency and Rotor Angle Engineering and Applied Sciences 2018; 3(1): 6-11 http://www.sciencepublishinggroup.com/j/eas doi: 10.11648/j.eas.20180301.12 ISSN: 2575-2022 (Print); ISSN: 2575-1468 (Online) Effect of Inertia Constant

More information

DHANALAKSHMI SRINIVASAN COLLEGE OF ENGINEERING AND TECHNOLOGY Mamalapuram Chennai QUESTION BANK V SEMESTER. EE6501-Power system Analysis

DHANALAKSHMI SRINIVASAN COLLEGE OF ENGINEERING AND TECHNOLOGY Mamalapuram Chennai QUESTION BANK V SEMESTER. EE6501-Power system Analysis DHANALAKSHMI SRINIVASAN COLLEGE OF ENGINEERING AND TECHNOLOGY Mamalapuram Chennai DEPARTMENT OF ELECTRICAL AND ELECTRONICS ENGINEERING QUESTION BANK V SEMESTER EE6501-Power system Analysis Regulation 2013

More information

SCHOOL OF ELECTRICAL, MECHANICAL AND MECHATRONIC SYSTEMS. Transient Stability LECTURE NOTES SPRING SEMESTER, 2008

SCHOOL OF ELECTRICAL, MECHANICAL AND MECHATRONIC SYSTEMS. Transient Stability LECTURE NOTES SPRING SEMESTER, 2008 SCHOOL OF ELECTRICAL, MECHANICAL AND MECHATRONIC SYSTEMS LECTURE NOTES Transient Stability SPRING SEMESTER, 008 October 7, 008 Transient Stability Transient stability refers to the ability of a synchronous

More information

ECE 422/522 Power System Operations & Planning/Power Systems Analysis II : 7 - Transient Stability

ECE 422/522 Power System Operations & Planning/Power Systems Analysis II : 7 - Transient Stability ECE 4/5 Power System Operations & Planning/Power Systems Analysis II : 7 - Transient Stability Spring 014 Instructor: Kai Sun 1 Transient Stability The ability of the power system to maintain synchronism

More information

ECE 585 Power System Stability

ECE 585 Power System Stability Homework 1, Due on January 29 ECE 585 Power System Stability Consider the power system below. The network frequency is 60 Hz. At the pre-fault steady state (a) the power generated by the machine is 400

More information

Power Angle & Time Domain Plots 1.0 The power-angle curves

Power Angle & Time Domain Plots 1.0 The power-angle curves Power Angle & Time Domain Plots 1.0 The power-angle curves Consider a generator connected to an infinite bus through a network, as shown in Fig. 1 below (all in pu). E E NETWORK X V V 0 Fig. 1 We assume

More information

EE2351 POWER SYSTEM ANALYSIS

EE2351 POWER SYSTEM ANALYSIS EE351 POWER SYSTEM ANALYSIS A.Ahamed Riazudeen EEE DEPARTMENT 1 UNIT I INTRODUCTION Power system network 3 SINGLE LINE DIAGRAM It is a diagrammatic representation of a power system in which the components

More information

ELEC4612 Power System Analysis Power Flow Analysis

ELEC4612 Power System Analysis Power Flow Analysis ELEC462 Power Sstem Analsis Power Flow Analsis Dr Jaashri Ravishankar jaashri.ravishankar@unsw.edu.au Busbars The meeting point of various components of a PS is called bus. The bus or busbar is a conductor

More information

Chapter 9: Transient Stability

Chapter 9: Transient Stability Chapter 9: Transient Stability 9.1 Introduction The first electric power system was a dc system built by Edison in 1882. The subsequent power systems that were constructed in the late 19 th century were

More information

1 Unified Power Flow Controller (UPFC)

1 Unified Power Flow Controller (UPFC) Power flow control with UPFC Rusejla Sadikovic Internal report 1 Unified Power Flow Controller (UPFC) The UPFC can provide simultaneous control of all basic power system parameters ( transmission voltage,

More information

ECEN 667 Power System Stability Lecture 15: PIDs, Governors, Transient Stability Solutions

ECEN 667 Power System Stability Lecture 15: PIDs, Governors, Transient Stability Solutions ECEN 667 Power System Stability Lecture 15: PIDs, Governors, Transient Stability Solutions Prof. Tom Overbye Dept. of Electrical and Computer Engineering Texas A&M University, overbye@tamu.edu 1 Announcements

More information

THE UNIVERSITY OF NEW SOUTH WALES. School of Electrical Engineering & Telecommunications FINALEXAMINATION. Session

THE UNIVERSITY OF NEW SOUTH WALES. School of Electrical Engineering & Telecommunications FINALEXAMINATION. Session Name: Student ID: Signature: THE UNIVERSITY OF NEW SOUTH WALES School of Electrical Engineering & Telecommunications FINALEXAMINATION Session 00 ELEC46 Power System Analysis TIME ALLOWED: 3 hours TOTAL

More information

Final Exam, Second Semester: 2015/2016 Electrical Engineering Department

Final Exam, Second Semester: 2015/2016 Electrical Engineering Department Philadelphia University Faculty of Engineering Student Name Student No: Serial No Final Exam, Second Semester: 2015/2016 Electrical Engineering Department Course Title: Power II Date: 21 st June 2016 Course

More information

Generators. What its all about

Generators. What its all about Generators What its all about How do we make a generator? Synchronous Operation Rotor Magnetic Field Stator Magnetic Field Forces and Magnetic Fields Force Between Fields Motoring Generators & motors are

More information

IGEE 402 Power System Analysis. FINAL EXAMINATION - SAMPLE Fall 2004

IGEE 402 Power System Analysis. FINAL EXAMINATION - SAMPLE Fall 2004 IGEE 402 Power System Analysis FINAL EXAMINATION - SAMPLE Fall 2004 Special instructions: - Duration: 80 minutes. - Material allowed: a crib sheet (double sided 8.5 x ), calculator. - Attempt 5 out of

More information

= V I = Bus Admittance Matrix. Chapter 6: Power Flow. Constructing Ybus. Example. Network Solution. Triangular factorization. Let

= V I = Bus Admittance Matrix. Chapter 6: Power Flow. Constructing Ybus. Example. Network Solution. Triangular factorization. Let Chapter 6: Power Flow Network Matrices Network Solutions Newton-Raphson Method Fast Decoupled Method Bus Admittance Matri Let I = vector of currents injected into nodes V = vector of node voltages Y bus

More information

CHAPTER 2 LOAD FLOW ANALYSIS FOR RADIAL DISTRIBUTION SYSTEM

CHAPTER 2 LOAD FLOW ANALYSIS FOR RADIAL DISTRIBUTION SYSTEM 16 CHAPTER 2 LOAD FLOW ANALYSIS FOR RADIAL DISTRIBUTION SYSTEM 2.1 INTRODUCTION Load flow analysis of power system network is used to determine the steady state solution for a given set of bus loading

More information

ELG4125: Power Transmission Lines Steady State Operation

ELG4125: Power Transmission Lines Steady State Operation ELG4125: Power Transmission Lines Steady State Operation Two-Port Networks and ABCD Models A transmission line can be represented by a two-port network, that is a network that can be isolated from the

More information

EE 581 Power Systems. Admittance Matrix: Development, Direct and Iterative solutions

EE 581 Power Systems. Admittance Matrix: Development, Direct and Iterative solutions EE 581 Power Systems Admittance Matrix: Development, Direct and Iterative solutions Overview and HW # 8 Chapter 2.4 Chapter 6.4 Chapter 6.1-6.3 Homework: Special Problem 1 and 2 (see handout) Overview

More information

Chapter 8 VOLTAGE STABILITY

Chapter 8 VOLTAGE STABILITY Chapter 8 VOTAGE STABIITY The small signal and transient angle stability was discussed in Chapter 6 and 7. Another stability issue which is important, other than angle stability, is voltage stability.

More information

ECEN 667 Power System Stability Lecture 18: Voltage Stability, Load Models

ECEN 667 Power System Stability Lecture 18: Voltage Stability, Load Models ECEN 667 Power System Stability Lecture 18: Voltage Stability, Load Models Prof. Tom Overbye Dept. of Electrical and Computer Engineering Texas A&M University, overbye@tamu.edu 1 Announcements Read Chapter

More information

ECE 325 Electric Energy System Components 7- Synchronous Machines. Instructor: Kai Sun Fall 2015

ECE 325 Electric Energy System Components 7- Synchronous Machines. Instructor: Kai Sun Fall 2015 ECE 325 Electric Energy System Components 7- Synchronous Machines Instructor: Kai Sun Fall 2015 1 Content (Materials are from Chapters 16-17) Synchronous Generators Synchronous Motors 2 Synchronous Generators

More information

LESSON 20 ALTERNATOR OPERATION OF SYNCHRONOUS MACHINES

LESSON 20 ALTERNATOR OPERATION OF SYNCHRONOUS MACHINES ET 332b Ac Motors, Generators and Power Systems LESSON 20 ALTERNATOR OPERATION OF SYNCHRONOUS MACHINES 1 LEARNING OBJECTIVES After this presentation you will be able to: Interpret alternator phasor diagrams

More information

Transient Stability Assessment and Enhancement Using TCSC with Fuzzy Logic Controller

Transient Stability Assessment and Enhancement Using TCSC with Fuzzy Logic Controller Transient Stability Assessment and Enhancement Using TCSC with Fuzzy Logic Controller Ali Qasim Hussein Department of Electrical Engineering, Acharya NAgarjuna University, Nagarjuna Nagar,Guntur,522510,Ap,

More information

Behaviour of synchronous machine during a short-circuit (a simple example of electromagnetic transients)

Behaviour of synchronous machine during a short-circuit (a simple example of electromagnetic transients) ELEC0047 - Power system dynamics, control and stability (a simple example of electromagnetic transients) Thierry Van Cutsem t.vancutsem@ulg.ac.be www.montefiore.ulg.ac.be/~vct October 2018 1 / 25 Objectives

More information

EE 6501 POWER SYSTEMS UNIT I INTRODUCTION

EE 6501 POWER SYSTEMS UNIT I INTRODUCTION EE 6501 POWER SYSTEMS UNIT I INTRODUCTION PART A (2 MARKS) 1. What is single line diagram? A Single line diagram is diagrammatic representation of power system in which the components are represented by

More information

1. Introduction. Keywords Transient Stability Analysis, Power System, Swing Equation, Three-Phase Fault, Fault Clearing Time

1. Introduction. Keywords Transient Stability Analysis, Power System, Swing Equation, Three-Phase Fault, Fault Clearing Time Energy and Power 17, 7(1): -36 DOI: 1.593/j.ep.1771.3 Numerical Simulations for Transient Stability Analysis of Two-Machine Power System Considering Three-Phase Fault under Different Fault Clearing Times

More information

IEEE PES Task Force on Benchmark Systems for Stability Controls

IEEE PES Task Force on Benchmark Systems for Stability Controls IEEE PES Task Force on Benchmark Systems for Stability Controls Ian Hiskens November 9, 3 Abstract This report summarizes a study of an IEEE -generator, 39-bus system. Three types of analysis were performed:

More information

SHORT QUESTIONS AND ANSWERS. Year/ Semester/ Class : III/ V/ EEE Academic Year: Subject Code/ Name: EE6501/ Power System Analysis

SHORT QUESTIONS AND ANSWERS. Year/ Semester/ Class : III/ V/ EEE Academic Year: Subject Code/ Name: EE6501/ Power System Analysis Srividya colllege of Engg & Tech,Virudhunagar Sri Vidya College of Engineering And Technology Virudhunagar 626 005 Department of Electrical and Electronics Engineering QUESTION BANK SHORT QUESTIONS AND

More information

EE 451 Power System Stability

EE 451 Power System Stability EE 451 Power System Stability Power system operates in synchronous mode Power system is subjected to a wide range of disturbances (small and large) - Loads and generation changes - Network changes - Faults

More information

Last Comments on Short-Circuit Analysis

Last Comments on Short-Circuit Analysis Last Comments on Short-Circuit Analysis.0 Exam summary Work all HW problems and know them; Read notes Read related book sections Topics:. Symmetrical faults (no book section) 2. Zbus building (9.3-9.6)

More information

Micro-grid to System Synchronization Based on Pre-Insertion Impedance Method (Version 1.0) By Peter Zhou University of Alberta Jan 30 th, 2015

Micro-grid to System Synchronization Based on Pre-Insertion Impedance Method (Version 1.0) By Peter Zhou University of Alberta Jan 30 th, 2015 Micro-grid to System Synchronization Based on Pre-Insertion Impedance Method (Version 1.0) By Peter Zhou University of Alberta Jan 30 th, 2015 Outline 1. What is Synchronization? 2. Synchronization Concerns?

More information

ECEN 667 Power System Stability Lecture 25: FFT, Energy Methods

ECEN 667 Power System Stability Lecture 25: FFT, Energy Methods ECEN 667 Power System Stability Lecture 5: FFT, Energy Methods Prof. Tom Overbye Dept. of Electrical and Computer Engineering Texas A&M University, overbye@tamu.edu 1 Announcements Read Chapter 9 Final

More information

EE2351 POWER SYSTEM OPERATION AND CONTROL UNIT I THE POWER SYSTEM AN OVERVIEW AND MODELLING PART A

EE2351 POWER SYSTEM OPERATION AND CONTROL UNIT I THE POWER SYSTEM AN OVERVIEW AND MODELLING PART A EE2351 POWER SYSTEM OPERATION AND CONTROL UNIT I THE POWER SYSTEM AN OVERVIEW AND MODELLING PART A 1. What are the advantages of an inter connected system? The advantages of an inter-connected system are

More information

Dynamic simulation of a five-bus system

Dynamic simulation of a five-bus system ELEC0047 - Power system dynamics, control and stability Dynamic simulation of a five-bus system Thierry Van Cutsem t.vancutsem@ulg.ac.be www.montefiore.ulg.ac.be/~vct November 2017 1 / 16 System modelling

More information

CHAPTER 2 DYNAMIC STABILITY MODEL OF THE POWER SYSTEM

CHAPTER 2 DYNAMIC STABILITY MODEL OF THE POWER SYSTEM 20 CHAPTER 2 DYNAMIC STABILITY MODEL OF THE POWER SYSTEM 2. GENERAL Dynamic stability of a power system is concerned with the dynamic behavior of the system under small perturbations around an operating

More information

CURENT Course Power System Coherency and Model Reduction

CURENT Course Power System Coherency and Model Reduction CURENT Course Power System Coherency and Model Reduction Prof. Joe H. Chow Rensselaer Polytechnic Institute ECSE Department November 1, 2017 Slow Coherency A large power system usually consists of tightly

More information

Comparative Study of Synchronous Machine, Model 1.0 and Model 1.1 in Transient Stability Studies with and without PSS

Comparative Study of Synchronous Machine, Model 1.0 and Model 1.1 in Transient Stability Studies with and without PSS Comparative Study of Synchronous Machine, Model 1.0 and Model 1.1 in Transient Stability Studies with and without PSS Abhijit N Morab, Abhishek P Jinde, Jayakrishna Narra, Omkar Kokane Guide: Kiran R Patil

More information

ECEN 667 Power System Stability Lecture 20: Oscillations, Small Signal Stability Analysis

ECEN 667 Power System Stability Lecture 20: Oscillations, Small Signal Stability Analysis ECEN 667 Power System Stability Lecture 20: Oscillations, Small Signal Stability Analysis Prof. Tom Overbye Dept. of Electrical and Computer Engineering Texas A&M University, overbye@tamu.edu 1 Announcements

More information

SECTION 5: POWER FLOW. ESE 470 Energy Distribution Systems

SECTION 5: POWER FLOW. ESE 470 Energy Distribution Systems SECTION 5: POWER FLOW ESE 470 Energy Distribution Systems 2 Introduction Nodal Analysis 3 Consider the following circuit Three voltage sources VV sss, VV sss, VV sss Generic branch impedances Could be

More information

Module 3 : Sequence Components and Fault Analysis

Module 3 : Sequence Components and Fault Analysis Module 3 : Sequence Components and Fault Analysis Lecture 12 : Sequence Modeling of Power Apparatus Objectives In this lecture we will discuss Per unit calculation and its advantages. Modeling aspects

More information

Dynamics of the synchronous machine

Dynamics of the synchronous machine ELEC0047 - Power system dynamics, control and stability Dynamics of the synchronous machine Thierry Van Cutsem t.vancutsem@ulg.ac.be www.montefiore.ulg.ac.be/~vct October 2018 1 / 38 Time constants and

More information

Power System Stability GENERATOR CONTROL AND PROTECTION

Power System Stability GENERATOR CONTROL AND PROTECTION Power System Stability Outline Basis for Steady-State Stability Transient Stability Effect of Excitation System on Stability Small Signal Stability Power System Stabilizers Speed Based Integral of Accelerating

More information

Power System Stability and Control. Dr. B. Kalyan Kumar, Department of Electrical Engineering, Indian Institute of Technology Madras, Chennai, India

Power System Stability and Control. Dr. B. Kalyan Kumar, Department of Electrical Engineering, Indian Institute of Technology Madras, Chennai, India Power System Stability and Control Dr. B. Kalyan Kumar, Department of Electrical Engineering, Indian Institute of Technology Madras, Chennai, India Contents Chapter 1 Introduction to Power System Stability

More information

Nonlinear Control Design of Series FACTS Devices for Damping Power System Oscillation

Nonlinear Control Design of Series FACTS Devices for Damping Power System Oscillation American Journal of Applied Sciences 8 (): 4-8, 0 ISSN 546-939 00 Science Publications Nonlinear Control Design of Series FACTS Devices for Damping Power System Oscillation Prechanon Kumkratug Department

More information

EVALUATION OF THE IMPACT OF POWER SECTOR REFORM ON THE NIGERIA POWER SYSTEM TRANSIENT STABILITY

EVALUATION OF THE IMPACT OF POWER SECTOR REFORM ON THE NIGERIA POWER SYSTEM TRANSIENT STABILITY EVALUATION OF THE IMPACT OF POWER SECTOR REFORM ON THE NIGERIA POWER SYSTEM TRANSIENT STABILITY F. I. Izuegbunam * Department of Electrical & Electronic Engineering, Federal University of Technology, Imo

More information

BEE701 POWER SYSTEM ANALYSIS

BEE701 POWER SYSTEM ANALYSIS BEE701 POWER SYSTEM ANALYSIS UNIT I POWER SYSTEM COMPONENTS Power system analysis The evaluation of power system is called as power system analysis Functions of power system analysis To monitor the voltage

More information

Chapter 9 Balanced Faults, Part II. 9.4 Systematic Fault Analysis Using Bus Impedance Matrix

Chapter 9 Balanced Faults, Part II. 9.4 Systematic Fault Analysis Using Bus Impedance Matrix Chapter 9 Balanced Faults, Part II 9.4 Systematic Fault Analysis Using Bus Impedance Matrix In the previous analysis we employed the Thevenin model and ound the Thevenin voltage and impedance by means

More information

Introduction to Synchronous. Machines. Kevin Gaughan

Introduction to Synchronous. Machines. Kevin Gaughan Introduction to Synchronous Machines Kevin Gaughan The Synchronous Machine An AC machine (generator or motor) with a stator winding (usually 3 phase) generating a rotating magnetic field and a rotor carrying

More information

Power Flow Analysis of Radial Distribution System using Backward/Forward Sweep Method

Power Flow Analysis of Radial Distribution System using Backward/Forward Sweep Method Power Flow Analysis of Radial Distribution System using Backward/Forward Sweep Method Gurpreet Kaur 1, Asst. Prof. Harmeet Singh Gill 2 1,2 Department of Electrical Engineering, Guru Nanak Dev Engineering

More information

Performance Of Power System Stabilizerusing Fuzzy Logic Controller

Performance Of Power System Stabilizerusing Fuzzy Logic Controller IOSR Journal of Electrical and Electronics Engineering (IOSR-JEEE) e-issn: 2278-1676,p-ISSN: 2320-3331, Volume 9, Issue 3 Ver. I (May Jun. 2014), PP 42-49 Performance Of Power System Stabilizerusing Fuzzy

More information

7. Transient stability

7. Transient stability 1 7. Transient stability In AC power system, each generator is to keep phase relationship according to the relevant power flow, i.e. for a certain reactance X, the both terminal voltages V1and V2, and

More information

The synchronous machine (SM) in the power system (2) (Where does the electricity come from)?

The synchronous machine (SM) in the power system (2) (Where does the electricity come from)? 1 The synchronous machine (SM) in the power system (2) (Where does the electricity come from)? 2 Lecture overview Synchronous machines with more than 2 magnetic poles The relation between the number of

More information

Simulating a Power System

Simulating a Power System Simulating a Power System Presented by Prof. Tyrone Fernando School of Electrical and Electronic Engineering (EECE), University of Western Australia (UWA) 1. Motivations In an actual power system, it is

More information

Transient Stability Assessment of Synchronous Generator in Power System with High-Penetration Photovoltaics (Part 2)

Transient Stability Assessment of Synchronous Generator in Power System with High-Penetration Photovoltaics (Part 2) Journal of Mechanics Engineering and Automation 5 (2015) 401-406 doi: 10.17265/2159-5275/2015.07.003 D DAVID PUBLISHING Transient Stability Assessment of Synchronous Generator in Power System with High-Penetration

More information

The Operation of a Generator on Infinite Busbars

The Operation of a Generator on Infinite Busbars The Operation of a Generator on Infinite Busbars In order to simplify the ideas as much as possible the resistance of the generator will be neglected; in practice this assumption is usually reasonable.

More information

Examples of Applications of Potential Functions in Problem Solving (Web Appendix to the Paper)

Examples of Applications of Potential Functions in Problem Solving (Web Appendix to the Paper) Examples of Applications of otential Functions in roblem Solving (Web Appendix to the aper) Ali Mehrizi-Sani and Reza Iravani May 5, 2010 1 Introduction otential functions may be exploited to formulate

More information

Fault Analysis Power System Representation

Fault Analysis Power System Representation .1. Power System Representation Single Line Diagram: Almost all modern power systems are three phase systems with the phases of equal magnitude and equal phase difference (i.e., 10 o ). These three phase

More information

DESIGNING POWER SYSTEM STABILIZER WITH PID CONTROLLER

DESIGNING POWER SYSTEM STABILIZER WITH PID CONTROLLER International Journal on Technical and Physical Problems of Engineering (IJTPE) Published by International Organization on TPE (IOTPE) ISSN 2077-3528 IJTPE Journal www.iotpe.com ijtpe@iotpe.com June 2010

More information

ELECTRIC POWER CIRCUITS BASIC CONCEPTS AND ANALYSIS

ELECTRIC POWER CIRCUITS BASIC CONCEPTS AND ANALYSIS Contents ELEC46 Power ystem Analysis Lecture ELECTRC POWER CRCUT BAC CONCEPT AND ANALY. Circuit analysis. Phasors. Power in single phase circuits 4. Three phase () circuits 5. Power in circuits 6. ingle

More information

Simulations and Control of Direct Driven Permanent Magnet Synchronous Generator

Simulations and Control of Direct Driven Permanent Magnet Synchronous Generator Simulations and Control of Direct Driven Permanent Magnet Synchronous Generator Project Work Dmitry Svechkarenko Royal Institute of Technology Department of Electrical Engineering Electrical Machines and

More information

Incorporation of Asynchronous Generators as PQ Model in Load Flow Analysis for Power Systems with Wind Generation

Incorporation of Asynchronous Generators as PQ Model in Load Flow Analysis for Power Systems with Wind Generation Incorporation of Asynchronous Generators as PQ Model in Load Flow Analysis for Power Systems with Wind Generation James Ranjith Kumar. R, Member, IEEE, Amit Jain, Member, IEEE, Power Systems Division,

More information

Model of Induction Machine to Transient Stability Programs

Model of Induction Machine to Transient Stability Programs Model of Induction Machine to Transient Stability Programs Pascal Garcia Esteves Instituto Superior Técnico Lisbon, Portugal Abstract- this paper reports the work performed on the MSc dissertation Model

More information

Chapter 3 AUTOMATIC VOLTAGE CONTROL

Chapter 3 AUTOMATIC VOLTAGE CONTROL Chapter 3 AUTOMATIC VOLTAGE CONTROL . INTRODUCTION TO EXCITATION SYSTEM The basic function of an excitation system is to provide direct current to the field winding of the synchronous generator. The excitation

More information

ANALYSIS OF SUBSYNCHRONOUS RESONANCE EFFECT IN SERIES COMPENSATED LINE WITH BOOSTER TRANSFORMER

ANALYSIS OF SUBSYNCHRONOUS RESONANCE EFFECT IN SERIES COMPENSATED LINE WITH BOOSTER TRANSFORMER ANALYSIS OF SUBSYNCHRONOUS RESONANCE EFFECT IN SERIES COMPENSATED LINE WITH BOOSTER TRANSFORMER G.V.RAJASEKHAR, 2 GVSSNS SARMA,2 Department of Electrical Engineering, Aurora Engineering College, Hyderabad,

More information

Transmission and Distribution of Electrical Power

Transmission and Distribution of Electrical Power KINGDOM OF SAUDI ARABIA Ministry Of High Education Umm Al-Qura University College of Engineering & Islamic Architecture Department Of Electrical Engineering Transmission and Distribution of Electrical

More information

POWER SYSTEM STABILITY AND CONTROL

POWER SYSTEM STABILITY AND CONTROL POWER SYSTEM STABILITY AND CONTROL P. KUNDUR Vice-President, Power Engineering Powertech Labs Inc., Surrey, British Columbia Formerly Manager Analytical Methods and Specialized Studies Department Power

More information

Q. 1 Q. 25 carry one mark each.

Q. 1 Q. 25 carry one mark each. Q. 1 Q. 25 carry one mark each. Q.1 Given ff(zz) = gg(zz) + h(zz), where ff, gg, h are complex valued functions of a complex variable zz. Which one of the following statements is TUE? (A) If ff(zz) is

More information

Regulating Transformers in Sequence Domain

Regulating Transformers in Sequence Domain ECE523: Lecture 25; Page 1/8 pu 1 Regulating Transformers in Sequence Domain A three-phase voltage regulating transformer has a per unit leakage reactance of.1, and steps the voltage from 69 kv to 35 kv.

More information

DESIGN OF POWER SYSTEM STABILIZER USING FUZZY BASED SLIDING MODE CONTROL TECHNIQUE

DESIGN OF POWER SYSTEM STABILIZER USING FUZZY BASED SLIDING MODE CONTROL TECHNIQUE DESIGN OF POWER SYSTEM STABILIZER USING FUZZY BASED SLIDING MODE CONTROL TECHNIQUE LATHA.R Department of Instrumentation and Control Systems Engineering, PSG College of Technology, Coimbatore, 641004,

More information

+ ( )= with initial condition

+ ( )= with initial condition Department of Electrical Engineering PhD. Admission Test Full Marks: 90 Time 90 minutes Date: 02.2.204 NAME: Appl. No: Write your answer on the question paper ONLY. All questions carry equal marks. PART

More information

Transient Stability Improvement of Multi-machine Power System Using Fuzzy Controlled TCSC

Transient Stability Improvement of Multi-machine Power System Using Fuzzy Controlled TCSC International Journal of Advancements in Research & Technology, Volume 1, Issue, July-1 Transient Stability Improvement of Multi-machine Power System Using Fuzzy Controlled TCSC GUNDALA SRINIVASA RAO,

More information

Investigation of Reactive Power Control and Compensation for HVDC Systems

Investigation of Reactive Power Control and Compensation for HVDC Systems Investigation of Reactive Power Control and Compensation for HVDC Systems By Yi Zhang A Thesis submitted to the Faculty of Graduate Studies of The University of Manitoba in partial fulfillment of the requirements

More information

Enhancement of transient stability analysis of multimachine power system

Enhancement of transient stability analysis of multimachine power system WWJMRD 2016; 2(6): 41-45 www.wwjmrd.com Impact Factor MJIF: 4.25 e-issn: 2454-6615 Oyediran Oyebode Olumide Department of Computer Engineering, Osun State Polytechnic Iree, Osun State, Nigeria Ogunwuyi

More information

Modelling and Analysis of Electric Power Systems

Modelling and Analysis of Electric Power Systems Modelling and Analysis of Electric Power Systems Power Flow Analysis Fault Analysis Power Systems Dynamics and Stability Lecture 227-0526-00, ITET ETH Zürich Göran Andersson EEH - Power Systems Laboratory

More information

POWER SEMICONDUCTOR BASED ELECTRIC DRIVES

POWER SEMICONDUCTOR BASED ELECTRIC DRIVES POWER SEMICONDUCT BASED ELECTRIC DRIVES [Time: 3 Hrs] [Max. Marks: 80] Instructions: Solve any six questions from Q.No (1 or 2), Q.No (3 or 4), Q.No (5 or 6), Q.No (7 or 8), Q.No (9 or 10), Q.No (11 or

More information

ECE 476. Exam #2. Tuesday, November 15, Minutes

ECE 476. Exam #2. Tuesday, November 15, Minutes Name: Answers ECE 476 Exam #2 Tuesday, November 15, 2016 75 Minutes Closed book, closed notes One new note sheet allowed, one old note sheet allowed 1. / 20 2. / 20 3. / 20 4. / 20 5. / 20 Total / 100

More information

Power system modelling under the phasor approximation

Power system modelling under the phasor approximation ELEC0047 - Power system dynamics, control and stability Thierry Van Cutsem t.vancutsem@ulg.ac.be www.montefiore.ulg.ac.be/~vct October 2018 1 / 16 Electromagnetic transient vs. phasor-mode simulations

More information

Chapter 31 Electromagnetic Oscillations and Alternating Current LC Oscillations, Qualitatively

Chapter 31 Electromagnetic Oscillations and Alternating Current LC Oscillations, Qualitatively Chapter 3 Electromagnetic Oscillations and Alternating Current LC Oscillations, Qualitatively In the LC circuit the charge, current, and potential difference vary sinusoidally (with period T and angular

More information

IEEE PES Task Force on Benchmark Systems for Stability Controls Report on the 68-Bus, 16-Machine, 5-Area System

IEEE PES Task Force on Benchmark Systems for Stability Controls Report on the 68-Bus, 16-Machine, 5-Area System IEEE PES Task Force on Benchmark Systems for Stability Controls Report on the 68-Bus, 16-Machine, 5-Area System Version 3.3-3 rd Dec, 2013 Abhinav Kumar Singh; and Bikash C. Pal The present report refers

More information

Example: Modeling DC Motor Position Physical Setup System Equations Design Requirements MATLAB Representation and Open-Loop Response

Example: Modeling DC Motor Position Physical Setup System Equations Design Requirements MATLAB Representation and Open-Loop Response Page 1 of 5 Example: Modeling DC Motor Position Physical Setup System Equations Design Requirements MATLAB Representation and Open-Loop Response Physical Setup A common actuator in control systems is the

More information

CHAPTER 5 SIMULATION AND TEST SETUP FOR FAULT ANALYSIS

CHAPTER 5 SIMULATION AND TEST SETUP FOR FAULT ANALYSIS 47 CHAPTER 5 SIMULATION AND TEST SETUP FOR FAULT ANALYSIS 5.1 INTRODUCTION This chapter describes the simulation model and experimental set up used for the fault analysis. For the simulation set up, the

More information

A Course Material on EE2351 POWER SYSTEM ANALYSIS

A Course Material on EE2351 POWER SYSTEM ANALYSIS A Course Material on EE2351 POWER SYSTEM ANALYSIS By Mrs. K. Umarani ASSISTANT PROFESSOR DEPARTMENT OF ELECTRICAL AND ELECTRONICS ENGINEERING SASURIE COLLEGE OF ENGINEERING VIJAYAMANGALAM 638 056 Page

More information

SECTION 7: FAULT ANALYSIS. ESE 470 Energy Distribution Systems

SECTION 7: FAULT ANALYSIS. ESE 470 Energy Distribution Systems SECTION 7: FAULT ANALYSIS ESE 470 Energy Distribution Systems 2 Introduction Power System Faults 3 Faults in three-phase power systems are short circuits Line-to-ground Line-to-line Result in the flow

More information

Transient Stability Analysis of Single Machine Infinite Bus System by Numerical Methods

Transient Stability Analysis of Single Machine Infinite Bus System by Numerical Methods International Journal of Electrical and Electronics Research ISSN 348-6988 (online) Vol., Issue 3, pp: (58-66), Month: July - September 04, Available at: www.researchpublish.com Transient Stability Analysis

More information

Massachusetts Institute of Technology Department of Electrical Engineering and Computer Science 6.061/6.690 Introduction to Power Systems

Massachusetts Institute of Technology Department of Electrical Engineering and Computer Science 6.061/6.690 Introduction to Power Systems Massachusetts Institute of Technology Department of Electrical Engineering and Computer Science 6.061/6.690 Introduction to Power Systems Problem Set 3 Solutions February 14, 2011 Problem 1: Voltage across

More information

PowerApps Optimal Power Flow Formulation

PowerApps Optimal Power Flow Formulation PowerApps Optimal Power Flow Formulation Page1 Table of Contents 1 OPF Problem Statement... 3 1.1 Vector u... 3 1.1.1 Costs Associated with Vector [u] for Economic Dispatch... 4 1.1.2 Costs Associated

More information

Power System Operations and Control Prof. S.N. Singh Department of Electrical Engineering Indian Institute of Technology, Kanpur. Module 3 Lecture 8

Power System Operations and Control Prof. S.N. Singh Department of Electrical Engineering Indian Institute of Technology, Kanpur. Module 3 Lecture 8 Power System Operations and Control Prof. S.N. Singh Department of Electrical Engineering Indian Institute of Technology, Kanpur Module 3 Lecture 8 Welcome to lecture number 8 of module 3. In the previous

More information

Power System Analysis Prof. A. K. Sinha Department of Electrical Engineering Indian Institute of Technology, Kharagpur

Power System Analysis Prof. A. K. Sinha Department of Electrical Engineering Indian Institute of Technology, Kharagpur Power System Analysis Prof. A. K. Sinha Department of Electrical Engineering Indian Institute of Technology, Kharagpur Lecture - 9 Transmission Line Steady State Operation Welcome to lesson 9, in Power

More information

Power Flow Analysis. The voltage at a typical bus i of the system is given in polar coordinates by

Power Flow Analysis. The voltage at a typical bus i of the system is given in polar coordinates by Power Flow Analysis 4.1 introduction: Power-flow studies are of great importance in planning and designing the future expansion of power systems as well as in determining the best operation of existing

More information

6. Oscillatory Stability and RE Design

6. Oscillatory Stability and RE Design 6. Oscillatory Stability and RE Design In chapter 4 and 5, it was clarified that voltage stability and transient synchronous stability are deeply influenced by power system model (power system load model

More information

Effect of Various Holomorphic Embeddings on Convergence Rate and Condition Number as Applied to the Power Flow Problem

Effect of Various Holomorphic Embeddings on Convergence Rate and Condition Number as Applied to the Power Flow Problem Effect of Various Holomorphic Embeddings on Convergence Rate and Condition Number as Applied to the Power Flow Problem Yuting Li Committee members: Dr. Daniel J. Tylavsky, Chair Dr. John Undrill Dr. Vijay

More information

MODELLING OF LOADS IN POWER

MODELLING OF LOADS IN POWER MODELLING OF LOADS IN POWER FLOW ANALYSIS SIBASISH KANUNGO (109EE0274) Department of Electrical Engineering National Institute of Technology Rourkela 1 MODELLING OF LOADS IN POWER FLOW ANALYSIS A Thesis

More information

Modeling of Hydraulic Turbine and Governor for Dynamic Studies of HPP

Modeling of Hydraulic Turbine and Governor for Dynamic Studies of HPP Modeling of Hydraulic Turbine and Governor for Dynamic Studies of HPP Nanaware R. A. Department of Electronics, Shivaji University, Kolhapur Sawant S. R. Department of Technology, Shivaji University, Kolhapur

More information