diff options
Diffstat (limited to '3872/CH11')
-rw-r--r-- | 3872/CH11/EX11.1/Ex11_1.jpg | bin | 0 -> 18923 bytes | |||
-rw-r--r-- | 3872/CH11/EX11.1/Ex11_1.sce | 21 | ||||
-rw-r--r-- | 3872/CH11/EX11.10/Ex11_10.jpg | bin | 0 -> 44604 bytes | |||
-rw-r--r-- | 3872/CH11/EX11.10/Ex11_10.sce | 47 | ||||
-rw-r--r-- | 3872/CH11/EX11.11/Ex11_11.JPG | bin | 0 -> 25293 bytes | |||
-rw-r--r-- | 3872/CH11/EX11.11/Ex11_11.sce | 43 | ||||
-rw-r--r-- | 3872/CH11/EX11.12/Ex11_12.jpg | bin | 0 -> 28121 bytes | |||
-rw-r--r-- | 3872/CH11/EX11.12/Ex11_12.sce | 28 | ||||
-rw-r--r-- | 3872/CH11/EX11.3/Ex11_3.jpg | bin | 0 -> 18442 bytes | |||
-rw-r--r-- | 3872/CH11/EX11.3/Ex11_3.sce | 24 | ||||
-rw-r--r-- | 3872/CH11/EX11.7/Ex11_7.jpg | bin | 0 -> 281439 bytes | |||
-rw-r--r-- | 3872/CH11/EX11.7/Ex11_7.sce | 52 | ||||
-rw-r--r-- | 3872/CH11/EX11.8/Ex11_8.JPG | bin | 0 -> 47173 bytes | |||
-rw-r--r-- | 3872/CH11/EX11.8/Ex11_8.sce | 47 |
14 files changed, 262 insertions, 0 deletions
diff --git a/3872/CH11/EX11.1/Ex11_1.jpg b/3872/CH11/EX11.1/Ex11_1.jpg Binary files differnew file mode 100644 index 000000000..37dd1c9b0 --- /dev/null +++ b/3872/CH11/EX11.1/Ex11_1.jpg diff --git a/3872/CH11/EX11.1/Ex11_1.sce b/3872/CH11/EX11.1/Ex11_1.sce new file mode 100644 index 000000000..b734b6168 --- /dev/null +++ b/3872/CH11/EX11.1/Ex11_1.sce @@ -0,0 +1,21 @@ +//Book - Power system: Analysisi & Design 5th Edition
+//Authors - J. Duncan Glover, Mulukutla S. Sarma, and Thomas J.Overbye
+//Chapter-11 ;Example 11.1
+//Scilab Version - 6.0.0; OS - Windows
+
+clc;
+clear;
+
+f=60 //frequency of hydroelectric generating unit
+Pr=500 //rated power of hydroelectric generator
+V=5 //rated voltage of hrdroelectric generator
+p=32 //pole of hydroelectric generating unit
+H=2.0 //Inertia constant in per unit-seconds
+
+Wsyn=2*%pi*f //Synchronous electrical radian frequency in rad/s
+Wmsyn=(2/p)*Wsyn //synchronous angular velocity of the rotor in rad/s
+
+printf('The Synchronous electrical radian frequency is %.4f rad/s\n',Wsyn);
+printf('The synchronous angular velocity of the rotor is %.4f rad/s',Wmsyn);
+
+
diff --git a/3872/CH11/EX11.10/Ex11_10.jpg b/3872/CH11/EX11.10/Ex11_10.jpg Binary files differnew file mode 100644 index 000000000..9320419de --- /dev/null +++ b/3872/CH11/EX11.10/Ex11_10.jpg diff --git a/3872/CH11/EX11.10/Ex11_10.sce b/3872/CH11/EX11.10/Ex11_10.sce new file mode 100644 index 000000000..62761ea11 --- /dev/null +++ b/3872/CH11/EX11.10/Ex11_10.sce @@ -0,0 +1,47 @@ +//Book - Power system: Analysisi & Design 5th Edition
+//Authors - J. Duncan Glover, Mulukutla S. Sarma, and Thomas J.Overbye
+//Chapter-11 ;Example 11.10
+//Scilab Version - 6.0.0; OS - Windows
+
+clc;
+clear;
+
+P=1.0 //Infinite bus received real power in per unit
+Vbus=1.0 //Infinite bus voltage in per unit
+Vr=1.0 //system voltage in per unit
+pf=0.95 //Lagging power factor
+Ra=0 //Machine resistance in per unit
+Xd=2.1 //direct axis reactance in per unit
+Xq=2.0 //qadrature axis reactance in per unit
+Xdt=0.3 //direct axis transient reactance in per unit
+Xqt=0.5 //qadrature axis transient reactance in per unit
+X=%i*0.22
+
+theta=acos(pf);
+I=(P/(Vbus*pf))*exp(-%i*theta); //generator output current in per unit
+VT=Vr+X*I //genertor terminal voltage in per unit
+Ireal=1 //generator real output current in per unit
+Iimag=-0.3287 //Generator imaginary output voltage in per unit
+Vreal=1.0723 //generator real terminal voltage in per unit
+Vimag=0.220 //Generator imaginary terminal voltage
+Ei=VT+(%i*Xq)*I //Steady state angle of internal voltage in per unitge
+del=52.1*%pi/180
+Vdq=[sin(del) -cos(del);cos(del) sin(del)]*[Vreal;Vimag]; //d-q reference voltage
+Idq=[sin(del) -cos(del);cos(del) sin(del)]*[Ireal;Iimag]; //d-q reference current
+Eqs=Vdq(2)+Xdt*Idq(1) //Quadrature axis transient voltage
+Eds=Vdq(1)-Xqt*Idq(2) //Direct axis transient voltage
+Efd=Eqs+(Xd-Xdt)*Idq(1) //field voltage
+
+printf('The generator output current is %.4f%.4fi per unit\n',real(I),imag(I));
+printf('The genertor terminal voltage is %.4f+%.4fi per unit\n',real(VT),imag(VT));
+printf('The magnitude of Steady state angle of internal voltage in per unit is %.4f and its angle is %.4f degrees\n',abs(Ei),atand(imag(Ei),real(Ei)));
+disp(Vdq,'The d-q reference voltage in per unit is');
+disp(Idq,'The d-q reference current in per unit is');
+printf('The Quadrature axis transient voltage is %.4f per unit\n',Eqs);
+printf('The Direct axis transient voltage is %.4f per unit\n',Eds);
+printf('The field voltage is %.4f per unit\n',Efd);
+
+
+
+
+
diff --git a/3872/CH11/EX11.11/Ex11_11.JPG b/3872/CH11/EX11.11/Ex11_11.JPG Binary files differnew file mode 100644 index 000000000..785eec224 --- /dev/null +++ b/3872/CH11/EX11.11/Ex11_11.JPG diff --git a/3872/CH11/EX11.11/Ex11_11.sce b/3872/CH11/EX11.11/Ex11_11.sce new file mode 100644 index 000000000..017e8c286 --- /dev/null +++ b/3872/CH11/EX11.11/Ex11_11.sce @@ -0,0 +1,43 @@ +//Book - Power system: Analysisi & Design 5th Edition
+//Authors - J. Duncan Glover, Mulukutla S. Sarma, and Thomas J.Overbye
+//Chapter-11 ;Example 11.11
+//Scilab Version - 6.0.0; OS - Windows
+
+clc;
+clear;
+
+f=60 //genertor frequency
+H=0.9 //Inertia constant in per unit-seconds
+Ra=0.013
+Xa=0.067 //leakage reactance
+Xm=3.8
+R1=0.0124
+X1=0.17
+S=-0.0111 //slip
+Ert=0.9314
+Eit=0.4117
+Ir=0.7974
+Ii=0.6586
+
+Xt=Xa+((X1*Xm)/(X1+Xm)); //transient reactance
+X=Xa+Xm; //synchronous reactance
+omega=2*%pi*f;
+Tot=((X1+Xm)/(omega*R1)); //open circuit time constant for the rotor
+
+Vr=Ert-(Ra*Ir)+(Xt*Ii);
+Vi=Eit-(Ra*Ii)-(Xt*Ir);
+dErt=(omega*S*Eit)-((1/Tot)*(Ert-(X-Xt)*Ii));
+dEit=(-(omega)*S*Ert)-((1/Tot)*(Eit+(X-Xt)*Ir));
+Pe=(Vr*Ir+Vi*Ii); //The terminal real power injection
+Qe=(-Vr*Ii+Vi*Ir); //The reactive power produced by the machine
+
+printf('The transient reactance is:%.4fi per unit\n',Xt);
+printf('The synchronous reactance is:%.4fi per unit\n',X);
+printf('The open circuit time constant for the rotor is:%.4fi per unit\n',Tot);
+printf('The terminal real power injection is:%.4f per unit\n',Pe);
+printf('The terminal reactive power injection is:%.4f per unit\n',Qe);
+
+
+
+
+
diff --git a/3872/CH11/EX11.12/Ex11_12.jpg b/3872/CH11/EX11.12/Ex11_12.jpg Binary files differnew file mode 100644 index 000000000..40961790a --- /dev/null +++ b/3872/CH11/EX11.12/Ex11_12.jpg diff --git a/3872/CH11/EX11.12/Ex11_12.sce b/3872/CH11/EX11.12/Ex11_12.sce new file mode 100644 index 000000000..d6248536c --- /dev/null +++ b/3872/CH11/EX11.12/Ex11_12.sce @@ -0,0 +1,28 @@ +//Book - Power system: Analysisi & Design 5th Edition
+//Authors - J. Duncan Glover, Mulukutla S. Sarma, and Thomas J.Overbye
+//Chapter-11 ;Example 11.12
+//Scilab Version - 6.0.0; OS - Windows
+
+clc;
+clear;
+
+
+Vr=1.0 //system voltage in per unit
+I=1.0 //terminal current
+pf=1 //Lagging power factor
+X=%i*0.22
+Xeq=0.8 //DFAG reactance in per unit
+
+
+
+VT=Vr+I*X //Terminal voltage
+Isorc=I+(VT/(%i*Xeq)) //current injection on the network reference in per unit
+Isorcpq=Isorc*(1*exp(%i*-12.41*%pi/180)) //The value of Ip and Iq are then calculated by shifting these values backwards by the angle of the terminal voltage
+Iq=-1.495 //reactive power current current
+Eq=-Iq*Xeq //The reactive voltage
+
+
+printf('The magnitude of terminal voltage in per unit is :%.4f and its angle is :%.4f degrees\n',abs(VT),atand(imag(VT),real(VT)));
+printf('The generator output current is:%.4f%.4fi per unit\n',real(Isorc),imag(Isorc));
+printf('The current injection on the network reference is:%.4f%.4fi per unit\n',real(Isorcpq),imag(Isorcpq));
+printf('The reactive voltage is:%.4f per unit\n',Eq);
diff --git a/3872/CH11/EX11.3/Ex11_3.jpg b/3872/CH11/EX11.3/Ex11_3.jpg Binary files differnew file mode 100644 index 000000000..785faf4fe --- /dev/null +++ b/3872/CH11/EX11.3/Ex11_3.jpg diff --git a/3872/CH11/EX11.3/Ex11_3.sce b/3872/CH11/EX11.3/Ex11_3.sce new file mode 100644 index 000000000..7ccaed87a --- /dev/null +++ b/3872/CH11/EX11.3/Ex11_3.sce @@ -0,0 +1,24 @@ +//Book - Power system: Analysisi & Design 5th Edition
+//Authors - J. Duncan Glover, Mulukutla S. Sarma, and Thomas J.Overbye
+//Chapter-11 ;Example 11.3
+//Scilab Version - 6.0.0; OS - Windows
+
+clc;
+clear;
+
+P=1.0 //Infinite bus received real power in per unit
+Vbus=1.0 //Infinite bus voltage in per unit
+pf=0.95 //Lagging power factor
+Xdt=0.30
+XTR=0.10
+X12=0.20
+X13=0.10
+X23=0.20
+
+Xeq=Xdt+XTR+(X12*(X13+X23))/(X12+(X13+X23)); //The equialent reactance between the machine internal voltage and infinite bus in per unit
+theta=acos(pf);
+I=(P/(Vbus*pf))*exp(-%i*theta); //Current into the infinite bus in per unit
+Ei=Vbus+(%i*Xeq)*I; //The machine internal voltage in per unit
+
+printf('The magnitude of he machine internal voltage in per unit is %.4f pu and its angle is %.4f degrees',abs(Ei),atand(imag(Ei),real(Ei)));
+
diff --git a/3872/CH11/EX11.7/Ex11_7.jpg b/3872/CH11/EX11.7/Ex11_7.jpg Binary files differnew file mode 100644 index 000000000..46f937aa7 --- /dev/null +++ b/3872/CH11/EX11.7/Ex11_7.jpg diff --git a/3872/CH11/EX11.7/Ex11_7.sce b/3872/CH11/EX11.7/Ex11_7.sce new file mode 100644 index 000000000..82622ecee --- /dev/null +++ b/3872/CH11/EX11.7/Ex11_7.sce @@ -0,0 +1,52 @@ +//Book - Power system: Analysisi & Design 5th Edition
+//Authors - J. Duncan Glover, Mulukutla S. Sarma, and Thomas J.Overbye
+//Chapter-11 ;Example 11.7
+//Scilab Version - 6.0.0; OS - Windows
+
+clc;
+clear;
+
+function result=table(delcr) //Function to get result in table format using Euler’s method for diferent critical clearing angles
+delta=0.4179 //Initial value of delta in rad taken from example 7.6
+omega=2*%pi*60 //Initial value of omega in rad/s
+H=3 //Value of H constant in pu-s
+omegasyn=omega
+t=0;
+delt=0.02 //Step size
+result=[]; //Initialization of result table
+tc=0; //Initialization of critical clearing time
+while t<0.861 //Maximum time for Eler's method is o.86
+ result=[result;t delta omega] //Updating the result table
+ ddeltat=omega-omegasyn //Calculation of ddeltat/dt using equation 11.4.7
+ deltab=delta+ddeltat*delt //Calculation of delta_bar using equation 11.4.9
+
+ if delta<delcr //Steps to calculate accelerating power for prefault condition
+ papu=1-0.9152*sin(delta)
+ pafb=1-0.9152*sin(deltab)
+ else //Steps to calculate accelerating power for postfault condition
+ tc=tc+1;
+ papu=1-2.1353*sin(delta)
+ pafb=1-2.1353*sin(deltab)
+ end
+ if tc==1 & delcr==1.95 //Displaying result of case 1(Stable) stable with Critical clearing angle of 1.95
+ printf('The critical clearing time for case 1 is %.2f sec\n',t)
+ elseif tc==1 & delcr==2.09 //Displaying result of case 2(Unstable) stable with Critical clearing angle of 2.09
+ printf('The critical clearing time for case 2 is %.2f sec\n',t)
+ end
+ domegat=papu*omegasyn*omegasyn/(2*H*omega) //Calculation of domegat/dt using equation 11.4.8
+ omegab=omega+domegat*delt //Calculation of omega_bar using equation 11.4.10
+ ddeltab=omegab-omegasyn //Calculation of ddelta_bar/dt using equation 11.4.11
+ domegab=pafb*omegasyn*omegasyn/(2*H*omegab) //Calculation of domega_bar/dt using equation 11.4.12
+ delta=delta+(ddeltat+ddeltab)*delt/2 //Calculation of delta for change in time using equation 11.4.13
+ omega=omega+(domegat+domegab)*delt/2 //Calculation of omega for change in time using equation 11.4.14
+ t=t+delt;
+end
+endfunction
+
+case1=table(1.95) //case1 - critical clearing angle is 1.95 rad
+case2=table(2.09) //case2 - critical clearing angle is 2.09 rad
+printf(' ----------------------------- -----------------------------\n')
+printf(' CASE-1 STABLE CASE-2 UNSTABLE \n')
+printf(' ----------------------------- -----------------------------')
+disp([case1 case2],'Time(s) Delta(rad) Omega(rad/s) Time(s) Delta(rad) Omega(rad/s)')
+
diff --git a/3872/CH11/EX11.8/Ex11_8.JPG b/3872/CH11/EX11.8/Ex11_8.JPG Binary files differnew file mode 100644 index 000000000..40b768895 --- /dev/null +++ b/3872/CH11/EX11.8/Ex11_8.JPG diff --git a/3872/CH11/EX11.8/Ex11_8.sce b/3872/CH11/EX11.8/Ex11_8.sce new file mode 100644 index 000000000..d19652c7c --- /dev/null +++ b/3872/CH11/EX11.8/Ex11_8.sce @@ -0,0 +1,47 @@ +//Book - Power system: Analysisi & Design 5th Edition
+//Authors - J. Duncan Glover, Mulukutla S. Sarma, and Thomas J.Overbye
+//Chapter-11 ;Example 11.8
+//Scilab Version - 6.0.0; OS - Windows
+
+clc;
+clear;
+linedata=[2 4 0.0090 0.10 1.72 //Entering line data from table 6.2 & 6.3 of example 6.9
+ 2 5 0.0045 0.05 0.88
+ 4 5 0.00225 0.025 0.44
+ 1 5 0.00150 0.02 0.00
+ 3 4 0.00075 0.01 0.00];
+sb= linedata(:,1);
+sb=linedata(:,1) //Starting bus number of all the lines stored in variable sb
+eb=linedata(:,2) //Ending bus number of all the lines stored in variable eb
+lz=linedata(:,3)+linedata(:,4)*%i; //lineimpedance=R+jX
+sa=linedata(:,5)*%i; //shunt admittance=jB since conductsnce G=0 for all lines
+nb=max(max(sb,eb));
+ybus=zeros(nb,nb);
+for i=1:length(sb)
+ m=sb(i);
+ n=eb(i);
+ ybus(m,m)=ybus(m,m)+1/lz(i)+sa(i)/2;
+ ybus(n,n)=ybus(n,n)+1/lz(i)+sa(i)/2;
+ ybus(m,n)=-1/lz(i);
+ ybus(n,m)=ybus(m,n);
+end
+Pl3=0.8;Ql3=0.4; Pl2=8; Ql2=2.8; //Data taken from table 6.1
+V3=1.05;V2=0.959;
+Qc=184; //Capacity of shunt capacitor in kVAR.
+xd1dash=0.05;
+xd2dash=0.025;
+Yl3=(Pl3-%i*Ql3)/V3^2;
+Yl2=(Pl2-%i*(Ql2-Qc/100))/V2^2;
+Yd1=1/(%i*xd1dash); //The inverted generator impedances for machine 1 connected to bus 1
+Yd2=1/(%i*xd2dash); //The inverted generator impedances for machine 2 connected to bus 3
+
+//Updation of bus admittance matrix
+Y11=ybus;
+Y11(1,1)=Y11(1,1)+Yd1;
+Y11(2,2)=Y11(2,2)+Yl2;
+Y11(3,3)=Y11(3,3)+Yl3+Yd2;
+disp(Y11,'The 5 x 5 matrix Y11 in per unit is given by:')
+Y22=[Yd1 0;0 Yd2];
+disp(Y22,'The 2 x 2 matrix Y22 in per unit is given by:')
+Y12=[Yd1 0;0 0;0 Yd2;0 0;0 0];
+disp(Y12,'The 5 x 2 matrix Y12 in per unit is given by:')
|