diff options
Diffstat (limited to '3872/CH5')
-rw-r--r-- | 3872/CH5/EX5.1/Ex5_1.JPG | bin | 0 -> 63847 bytes | |||
-rw-r--r-- | 3872/CH5/EX5.1/Ex5_1.sce | 60 | ||||
-rw-r--r-- | 3872/CH5/EX5.10/Ex5_10.JPG | bin | 0 -> 22702 bytes | |||
-rw-r--r-- | 3872/CH5/EX5.10/Ex5_10.sce | 28 | ||||
-rw-r--r-- | 3872/CH5/EX5.2/Ex5_2.JPG | bin | 0 -> 39429 bytes | |||
-rw-r--r-- | 3872/CH5/EX5.2/Ex5_2.sce | 32 | ||||
-rw-r--r-- | 3872/CH5/EX5.3/Ex5_3.JPG | bin | 0 -> 44329 bytes | |||
-rw-r--r-- | 3872/CH5/EX5.3/Ex5_3.sce | 30 | ||||
-rw-r--r-- | 3872/CH5/EX5.4/Ex5_4.JPG | bin | 0 -> 19630 bytes | |||
-rw-r--r-- | 3872/CH5/EX5.4/Ex5_4.sce | 22 | ||||
-rw-r--r-- | 3872/CH5/EX5.5/Ex5_5.JPG | bin | 0 -> 22650 bytes | |||
-rw-r--r-- | 3872/CH5/EX5.5/Ex5_5.sce | 24 | ||||
-rw-r--r-- | 3872/CH5/EX5.6/Ex5_6.JPG | bin | 0 -> 34380 bytes | |||
-rw-r--r-- | 3872/CH5/EX5.6/Ex5_6.sce | 52 | ||||
-rw-r--r-- | 3872/CH5/EX5.7/Ex5_7.JPG | bin | 0 -> 49351 bytes | |||
-rw-r--r-- | 3872/CH5/EX5.7/Ex5_7.sce | 45 | ||||
-rw-r--r-- | 3872/CH5/EX5.8/Ex5_8.JPG | bin | 0 -> 27857 bytes | |||
-rw-r--r-- | 3872/CH5/EX5.8/Ex5_8.sce | 29 | ||||
-rw-r--r-- | 3872/CH5/EX5.9/Ex5_9.JPG | bin | 0 -> 35496 bytes | |||
-rw-r--r-- | 3872/CH5/EX5.9/Ex5_9.sce | 36 |
20 files changed, 358 insertions, 0 deletions
diff --git a/3872/CH5/EX5.1/Ex5_1.JPG b/3872/CH5/EX5.1/Ex5_1.JPG Binary files differnew file mode 100644 index 000000000..5c62432ef --- /dev/null +++ b/3872/CH5/EX5.1/Ex5_1.JPG diff --git a/3872/CH5/EX5.1/Ex5_1.sce b/3872/CH5/EX5.1/Ex5_1.sce new file mode 100644 index 000000000..78ddea092 --- /dev/null +++ b/3872/CH5/EX5.1/Ex5_1.sce @@ -0,0 +1,60 @@ +// Book - Power System: Analysis & Design 5th Edition
+// Authors - J. Duncan Glover, Mulukutla S. Sharma, Thomas J. Overbye
+// Chapter - 5 : Example 5.1
+// Scilab Version 6.0.0 : OS - Windows
+
+clc;
+clear;
+
+f = 60; // Frequency in Hz
+N = 2; // Number of Conductors
+V = 345; // Voltage in kV
+L = 200; // Line length
+S = 795000; // Size of the conductor
+z = 0.032+(%i*0.35); // Impedance in Ohm/km
+y = (%i)*(4.2*10^-6); // Admitance in S/km
+Pr = 700; // Full load Power in MW
+pf = 0.99; // Power factor
+v = 95/100; // rated voltage
+
+Z = z*L; // Total series impedance
+Y = y*L; // Total shunt Admitance
+A = 1 + ((Y*Z)/2); // Line Paramater A in per unit
+D = A; // Line Paramater D in per unit
+B = Z; // Line Paramater B in Ohm
+C = Y*(1+(Y*Z)/4); // Line Paramater C in Siemens
+
+VrLL = V*v; // Receiving end Line to Line Voltage in kVLL
+VrLN = VrLL/sqrt(3); // Receiving end Line to Neutral Voltage in kVLN
+theta = acos(pf);
+Ir = (((Pr)*exp(%i*theta))/(sqrt(3)*(v*V)*(pf))); // Receiving end current in kA
+VsLN = ((A*VrLN)+(B*Ir)); // Sending end Line to Neutral Voltage in kVLN
+VsLL = abs(VsLN)*sqrt(3); // sending end Line to Line Voltage in kVLL
+Is = ((C*VrLN)+(D*Ir)); // sending end current in kA
+[r theta1] = polar(VsLN);
+[r theta2] = polar(Is);
+Ps = sqrt(3)*abs(VsLL)*abs(Is)*cos(theta1-theta2); // Power delivered to the sending end in MW
+
+VrNL = abs(VsLL)/abs(A); // No load receiving end voltage in kVLL
+PercentVR = ((abs(VrNL)-abs(VrLL))/abs(VrLL))*100; // Full load voltage in percent
+
+J = N*0.9; // Approximate Current carrying capacity of 2 ACSR conductors in kA taken From table A.4
+P = Ps-Pr; // Full load line losses in MW
+PercentEFF = (Pr/Ps)*100; // Full load transmission efficiency in percent
+
+printf('The magnitude of Transmission line parameter A in per unit is %0.4f and its angle is %0.3f degree', abs(A), atand(imag(A), real(A)));
+printf('\nThe magnitude of Transmission line parameter B in Ohm is %0.2f and its angle is %0.2f degree', abs(B), atand(imag(B), real(B)));
+printf('\nThe magnitude of Transmission line parameter C in Siemens is %0.2e and its angle is %0.2f degree', abs(C), atand(imag(C), real(C)));
+printf('\nThe magnitude of Transmission line parameter D in per unit is %0.4f and its angle is %0.3f degree', abs(D), atand(imag(D), real(D)));
+
+printf('\n\nSending end Line to Neutral Voltage in kVLN is : %0.1f and its angle is : %0.2f degree', abs(VsLN), atand(imag(VsLN), real(VsLN)));
+printf('\nSending end Line to Line Voltage is (VsLL) = %0.1f kV', abs(VsLL));
+printf('\nThe magnitude of sending end current in kA is (Is) : %0.3f and its angle is : %0.2f degree', abs(Is), atand(imag(Is), real(Is)));
+printf('\nPower delivered to the sending end is (Ps) = %0.1f MW', Ps);
+
+printf('\n\nNo load receiving end voltage is (VrNL) = %0.1f kVLL', VrNL);
+printf('\nFull load voltage is (Percent VR) = %0.1f Percent', PercentVR);
+
+printf('\n\nApproximate Current carrying capacity of 2 ACSR conductors is (J) = %0.1f kA', J);
+printf('\nFull load line losses is (P) = %0.1f MW', P);
+printf('\nFull load transmission efficiency is (Percent EFF) = %0.1f Percent', PercentEFF);
diff --git a/3872/CH5/EX5.10/Ex5_10.JPG b/3872/CH5/EX5.10/Ex5_10.JPG Binary files differnew file mode 100644 index 000000000..ed948dda1 --- /dev/null +++ b/3872/CH5/EX5.10/Ex5_10.JPG diff --git a/3872/CH5/EX5.10/Ex5_10.sce b/3872/CH5/EX5.10/Ex5_10.sce new file mode 100644 index 000000000..6b9fd554a --- /dev/null +++ b/3872/CH5/EX5.10/Ex5_10.sce @@ -0,0 +1,28 @@ +// Book - Power System: Analysis & Design 5th Edition
+// Authors - J. Duncan Glover, Mulukutla S. Sharma, Thomas J. Overbye
+// Chapter - 5 : Example 5.10
+// Scilab Version 6.0.0 : OS - Windows
+
+clc;
+clear;
+
+Comp = 30/100; // Compensation in percent
+Vs = 765; // Sending end voltage in kV
+Vr = Vs; // Receiving end voltage in kV
+Z = 97.02; // Absolute eqivalent pi circuit value ; Taken from Ex 5.3
+PRmaxun=5738 // Maximum power that can be delivered by uncompensated line(From example 5.5)
+F1 = sind(87.210); // Eqivalent pi circuit angle ; Taken from Ex 5.3
+X1 = Z*F1; // Eqivalent series reactance without compensation in Ohm ; taken from Ex 5.3
+Zcap = -(%i)*(1/2)*Comp*X1; // Impedance of series capacitor in Ohm
+ABCD = [1 Zcap; 0 1]; // From figure 5.4 for series impedance the ABCD matrix
+ABCD2 = [ 0.9313*exp(%i*0.209*%pi/180) 97.0*exp(%i*87.2*%pi/180);
+ 1.37*10^(-3)*exp(%i*90.06*%pi/180) 0.9313*exp(%i*0.209*%pi/180) ]; // The ABCD parameters taken from Ex 5.2
+ABCDeq = ABCD*ABCD2*ABCD; // The eqivalent ABCD matrix of the compensated line
+Aeq = abs(ABCDeq(1,1)); // Absolute value of the line parameter A
+thetaAeq = atand(imag(ABCDeq(1,1))/real(ABCDeq(1,1))); // Angle value of the line parameter A
+Beq = abs(ABCDeq(1,2)); // Absolute value of the line parameter B
+thetaBeq = atand(imag(ABCDeq(1,2))/real(ABCDeq(1,2))); // Angle value of the line parameter B
+PRmax=(Vs^2/Beq)-(Aeq*Vs^2/Beq)*cosd(thetaBeq-thetaAeq); // maximum power that can be delivered
+dif=(PRmax/PRmaxun)*100-100; // Percentage difference in power delivered between compensated and uncompensated line
+printf('The theoretical maximum power that this compensated line can deliver is %d MW',PRmax)
+printf('\nThe power delivered by compensated line is %.2f percent more than that of uncompensated line',dif)
diff --git a/3872/CH5/EX5.2/Ex5_2.JPG b/3872/CH5/EX5.2/Ex5_2.JPG Binary files differnew file mode 100644 index 000000000..83c28c796 --- /dev/null +++ b/3872/CH5/EX5.2/Ex5_2.JPG diff --git a/3872/CH5/EX5.2/Ex5_2.sce b/3872/CH5/EX5.2/Ex5_2.sce new file mode 100644 index 000000000..c1ad005a7 --- /dev/null +++ b/3872/CH5/EX5.2/Ex5_2.sce @@ -0,0 +1,32 @@ +// Book - Power System: Analysis & Design 5th Edition
+// Authors - J. Duncan Glover, Mulukutla S. Sharma, Thomas J. Overbye
+// Chapter - 5 : Example 5.2
+// Scilab Version 6.0.0 : OS - Windows
+
+clc;
+clear;
+
+V = 765; // Line voltage in kV
+f = 60; // frequency in Hz
+L = 300; // line length in km
+z = 0.0165+(%i*0.3306); // Positive sequence impedance in Ohm/km
+y = %i*4.674e-6; // Positive sequence admitance in S/km
+Zc = sqrt(z/y); // Characteristic impedance in Ohm
+GammaL = sqrt(z*y)*L; // Propagation constant in per unit
+eGammaL = exp(0.00930)*exp(%i*0.3730);
+eNegGammaL = exp(-0.00930)*exp(-%i*0.3730);
+coshGammaL = (eGammaL+eNegGammaL)/2; // Hyperbolic function
+sinhGammaL = (eGammaL-eNegGammaL)/2; // Hyperbolic function
+A = cosh(GammaL); // line parameter in per unit
+D = A; // line parameter in per unit
+B = Zc*sinh(GammaL); // line parameter in Ohm
+C = (1/Zc)*sinh(GammaL); // Line parameter in S
+Bnominalpi = z*L; // The B parameter for the nominal pi circuit in Ohm
+Bdiff=100-(abs(B)/abs(Bnominalpi))*100; //The difference in B parameter in percentage
+
+printf('\n\The line parameter A in per unit is %0.4f and its angle is : %0.3f degree', abs(A), atand(imag(A), real(A)));
+printf('\nThe line parameter B in Ohm is %0.1f and its angle is : %0.1f degree', abs(B), atand(imag(B), real(B)));
+printf('\nThe line parameter C in Siemens is %0.2e and its angle is : %0.2f degree', abs(C), atand(imag(C), real(C)));
+printf('\n\The line parameter D in per unit is %0.4f and its angle is : %0.3f degree', abs(A), atand(imag(A), real(A)));
+printf('\nThe B parameter for the nominal pi circuit in Ohm is (Bnominalpi) : %0.1f and its angle is : %0.2f degree', abs(Bnominalpi), atand(imag(Bnominalpi), real(Bnominalpi)));
+printf('\nThe difference in B parameter for the nominal pi circuit is %d percentage',Bdiff)
diff --git a/3872/CH5/EX5.3/Ex5_3.JPG b/3872/CH5/EX5.3/Ex5_3.JPG Binary files differnew file mode 100644 index 000000000..676e67729 --- /dev/null +++ b/3872/CH5/EX5.3/Ex5_3.JPG diff --git a/3872/CH5/EX5.3/Ex5_3.sce b/3872/CH5/EX5.3/Ex5_3.sce new file mode 100644 index 000000000..3aa967acf --- /dev/null +++ b/3872/CH5/EX5.3/Ex5_3.sce @@ -0,0 +1,30 @@ +// Book - Power System: Analysis & Design 5th Edition
+// Authors - J. Duncan Glover, Mulukutla S. Sharma, Thomas J. Overbye
+// Chapter - 5 : Example 5.3
+// Scilab Version 6.0.0 : OS - Windows
+
+clc;
+clear;
+
+z = 0.0165+(%i*0.3306); // Positive sequence impedance in Ohm/km
+y = %i*4.674*10^-6; // Positive sequence admitance in S/km
+L = 300; // line length in km
+
+Z = z*L; // Circuit Impedance in Ohm
+Y = (y/2)*L; // Circuit admitance in Siemens
+GammaL = sqrt(z*y)*L; // Propagation constant in per unit
+F1 = sinh(GammaL)/(GammaL); // Correction factor in per unit
+F2 = tanh(GammaL/2)/(GammaL/2); // Correction factor in per unit
+Z1 = Z*F1; // Eqivalent pi circuit value in Ohm
+Y1 = (Y)*(F2); // Shunt admitance of a Eqivalent pi circuit in Siemens
+Zc=100-(abs(Z)*100/abs(Z1)) //Difference in Z for nominal and equivalent pi circuits
+Yc=100-(abs(Y)*100/abs(Y1)) //Difference in Y/2 for nominal and equivalent pi circuits
+
+printf('Nominal pi Circuit value Z in Ohm is %0.4f and its angle is %0.3f degree', abs(Z), atand(imag(Z), real(Z)));
+printf('\nNominal pi Circuit value Y/2 in Siemens is %0.4e and its angle is %0.3f degree', abs(Y), atand(imag(Y), real(Y)));
+printf('\n\nEqivalent pi circuit value Z1 in Ohm is %0.2f and its angle is %0.3f degree', abs(Z1), atand(imag(Z1), real(Z1)));
+printf('\nShunt admitance Y1/2 of Eqivalent pi circuit is %0.5e + i%0.3e Siemens', real(Y1), imag(Y1));
+printf('\n\nThe difference in Z1 for nominal pi and equivalent pi circuit is %d percentage',Zc)
+printf('\nThe difference in Y1/2 for nominal pi and equivalent pi circuit is %d percentage',Yc)
+
+
diff --git a/3872/CH5/EX5.4/Ex5_4.JPG b/3872/CH5/EX5.4/Ex5_4.JPG Binary files differnew file mode 100644 index 000000000..bed5bdabc --- /dev/null +++ b/3872/CH5/EX5.4/Ex5_4.JPG diff --git a/3872/CH5/EX5.4/Ex5_4.sce b/3872/CH5/EX5.4/Ex5_4.sce new file mode 100644 index 000000000..56fa8cbe0 --- /dev/null +++ b/3872/CH5/EX5.4/Ex5_4.sce @@ -0,0 +1,22 @@ +// Book - Power System: Analysis & Design 5th Edition
+// Authors - J. Duncan Glover, Mulukutla S. Sharma, Thomas J. Overbye
+// Chapter - 5 : Example 5.4
+// Scilab Version 6.0.0 : OS - Windows
+
+clc;
+clear;
+
+L = 300; // Line length in km
+SI = 266.1; // Surge impedance in Ohm
+lambda = 5000; // Wavelength in km
+Vs = 765; // Sending end voltage in kV
+Vr = Vs; // Receiving end voltage in kV
+
+SIL = (Vs)^2/SI; // Surge impedance load in MW
+Vspu = (765/765); // Sending end voltage in per unit
+Vrpu = (765/765); // Receiving end voltage in per unit
+Pmax = Vspu*Vrpu*SIL/sin(2*%pi*L/lambda); // The theoretical steady state stability limit of a lossless line in MW
+SSL = 2.72*SIL; // Theoretically steady state stability limit in MW; taken from Figure 5.12
+
+printf('\nThe steady state stability limit of a lossless line is (Pmax) = %0.0f MW', Pmax);
+printf('\n\n Theoretically steady state stability limit is (SSL) = %0.0f MW', SSL);
diff --git a/3872/CH5/EX5.5/Ex5_5.JPG b/3872/CH5/EX5.5/Ex5_5.JPG Binary files differnew file mode 100644 index 000000000..ce610ba85 --- /dev/null +++ b/3872/CH5/EX5.5/Ex5_5.JPG diff --git a/3872/CH5/EX5.5/Ex5_5.sce b/3872/CH5/EX5.5/Ex5_5.sce new file mode 100644 index 000000000..7d4c1db7a --- /dev/null +++ b/3872/CH5/EX5.5/Ex5_5.sce @@ -0,0 +1,24 @@ +// Book - Power System: Analysis & Design 5th Edition
+// Authors - J. Duncan Glover, Mulukutla S. Sharma, Thomas J. Overbye
+// Chapter - 5 : Example 5.5
+// Scilab Version 6.0.0 : OS - Windows
+
+clc;
+clear;
+
+Vs = 765; // Sending end voltage in kV
+Vr= Vs; // receiving end voltage is equal to sending end voltage
+
+A = 0.9313; // Absolute line paramter A value in per unit from Ex 5.2
+thetaA = 0.209*(%pi/180); // angle value of Parameter A in degree from Ex 5.2
+B = 97; // Absolute line paramter B value in Ohm from Ex 5.2
+thetaZ = 87.2*(%pi/180); // angle value of Parameter B in degree from Ex 5.2
+Z1 = B;
+Zc = 266.1; // The magnitude of Characteristic impedance in ohm from Ex 5.2
+PrMAX1 = ((Vr*Vs)/Z1)-(((A*Vr^2)/Z1)*(cos(thetaZ-thetaA))); // The theoretical maximum real power delivered in MW
+SIL = (Vr)^2/Zc; // Surge Impedance Load in MW
+PrMAX2 = PrMAX1/SIL; // The theoretical maximum real power delivered in per unit
+
+printf('The theoretical maximun power delivered is (PrMAX1) = %d MW', PrMAX1);
+printf('\nSurge Impedance Load is (SIL) = %d MW', SIL);
+printf('\n\nThe theoretical maximun power delivered in pu of SIL is (PrMAX2) = %0.2f per unit', PrMAX2);
diff --git a/3872/CH5/EX5.6/Ex5_6.JPG b/3872/CH5/EX5.6/Ex5_6.JPG Binary files differnew file mode 100644 index 000000000..eecab45e4 --- /dev/null +++ b/3872/CH5/EX5.6/Ex5_6.JPG diff --git a/3872/CH5/EX5.6/Ex5_6.sce b/3872/CH5/EX5.6/Ex5_6.sce new file mode 100644 index 000000000..976d6f4d9 --- /dev/null +++ b/3872/CH5/EX5.6/Ex5_6.sce @@ -0,0 +1,52 @@ +// Book - Power System: Analysis & Design 5th Edition
+// Authors - J. Duncan Glover, Mulukutla S. Sharma, Thomas J. Overbye
+// Chapter - 5 : Example 5.6
+// Scilab Version 6.0.0 : OS - Windows
+
+clc;
+clear;
+
+N = 4; // Number of Conductors
+l = 300; // Line lenght in km
+s = 1272000; // Size of the conductor in cmil
+Vs1 = 765; // Sending end voltage in kV
+V = 765; // Base Voltage
+Vr1 = 0.95*765; // Receiving end voltage in kV
+
+delta = 35; // Phase angle in degree
+Z1 = 97; // Absolute line paramter value in Ohm from Ex 5.5
+thetaZ = 87.2; // Angle value of Parameter B in radians from Ex 5.5
+A = 0.9313; // Absolute line paramter value in per unit from Ex 5.5
+thetaA = 0.209; // Angle value of Parameter A in degree from Ex 5.5
+Pr = (((Vr1*Vs1)/Z1)*cosd(thetaZ-delta))-(((A*(Vr1)^2)/Z1)*cosd(thetaZ-thetaA)); // The real power delivered to the receiving end in MW
+SIL = 2199; // Surge Impedance Load in MW taken from Ex 5.5
+L = 1.49; // Loadability in per unit of SIL taken from fig 5.12
+LL = L*SIL; // Practical Line loadability in MW using fig. 5.12
+
+pf = 0.986; // Power factor
+IRFL = Pr/(sqrt(3)*Vr1*pf); // Full load receiving end current in kA
+
+A = 0.9313*exp(%i*0.209)*(%pi/180); // Line parameter value in per unit taken from Ex 5.2
+B = 97.0*exp(%i*87.20)*(%pi/180); // Line parameter value in Ohm taken from Ex 5
+theta = acos(pf);
+Irfl = 2.616*exp(%i*theta);
+Vs2 = Vs1/sqrt(3); // line Voltage in kV
+a = 0.8673; // coefficient of second order Vrfl from the equation in part c
+b = -54.24; // coefficient Vrfl from the equation in part c
+c = -130707.89; // coefficient constant from the equation in part c
+Vrfl = (-b+sqrt((b^2)-(4*a*c)))/(2*a); // Vrfl value from the 2nd order Quadratic equation
+Vrfl2 = Vrfl*sqrt(3); // Full load receiving end voltage in kVLL
+VRFL = Vrfl2/V; // Full load receiving end in per unit
+
+absA = 0.9313; // Absolute value of A taken from Ex 5.2
+VRNL = V/absA; // The receiving end no load voltage in kVLL taken from 5.1.19
+PercentVR = ((VRNL-Vrfl2)/Vrfl2)*100; // Full load voltage in percent
+
+J = N*1.2; // Approximate Current carrying capacity of 4 ACSR conductors in kA taken From table A.4
+
+printf('\nPractical line loadability is (LL) = %0.0f MW', Pr);
+printf('\nFull load receiving end current is (Irfl) = %0.3f kA', IRFL);
+printf('\nFull load receiving end voltage is (VRFL) = %0.3f per unit', VRFL);
+printf('\nThe receiving end no load voltage is (VRNL) = %0.1f kVLL', VRNL);
+printf('\nFull load voltage is (PercentVR) = %0.2f Percent', PercentVR);
+printf('\nApproximate Current carrying capacity of 4 ACSR conductors is (J) = %0.1f kA', J);
diff --git a/3872/CH5/EX5.7/Ex5_7.JPG b/3872/CH5/EX5.7/Ex5_7.JPG Binary files differnew file mode 100644 index 000000000..e25daae54 --- /dev/null +++ b/3872/CH5/EX5.7/Ex5_7.JPG diff --git a/3872/CH5/EX5.7/Ex5_7.sce b/3872/CH5/EX5.7/Ex5_7.sce new file mode 100644 index 000000000..00aad96c6 --- /dev/null +++ b/3872/CH5/EX5.7/Ex5_7.sce @@ -0,0 +1,45 @@ +// Book - Power System: Analysis & Design 5th Edition
+// Authors - J. Duncan Glover, Mulukutla S. Sharma, Thomas J. Overbye
+// Chapter - 5 : Example 5.7
+// Scilab Version 6.0.0 : OS - Windows
+
+clc;
+clear;
+
+p = 9000; // Power in MW
+l = 500; // Load center distance from the plant in km
+f = 60; // Frequency in Hz
+Vs = 1.0; // Sending end voltage in per unit
+Vr = 0.95; // Receiving end voltage in per unit
+delta = 35*(%pi/180); // Phase angle in degree
+lamdba = 5000; // Wavelength in km
+
+v1 = 345; // 1st line voltage in kV
+Zc1 = 297; // Characteristic impedance of 1st line in Ohm
+SIL1 = (v1^2)/Zc1; // Surge Impedance Load for line 1 in MW
+P1 = (Vs*Vr*SIL1*sin(delta))/(sin((2*%pi*l)/lamdba)); // Real power delivered for line 1 without losses in MW/line
+line1 = ceil((p/P1)+1); // Lines required to transmit 9000 MW power with 345 kV line out of service
+
+v2 = 500; // 2nd line voltage in kV
+Zc2 = 277; // Characteristic impedance of 2nd line in Ohm
+SIL2 = (v2^2)/Zc2; // Surge Impedance Load for line 2 in MW
+P2 = (Vs*Vr*SIL2*sin(delta))/(sin((2*%pi*l)/lamdba)); // Real power delivered for line 2 without losses in MW/line
+line2 = ceil((p/P2)+1); // Lines required to transmit 9000 MW power with 500 kV line out of service
+
+v3 = 765; // 3rd line voltage in kV
+Zc3 = 266; // Characteristic impedance of 3rd line in Ohm
+SIL3 = (v3^2)/Zc3; // Surge Impedance Load for line 3 in MW
+P3 = (Vs*Vr*SIL3*sin(delta))/(sin((2*%pi*l)/lamdba)); // Real power delivered for line 3 without losses in MW/line
+line3 = ceil((p/P3)+1); // Lines required to transmit 9000 MW power with 765 kV line out of service
+
+printf('\n Surge Impedance Load for line 1 is = %0.0f MW', SIL1);
+printf('\nReal power delivered for line 1 without losses is = %0.0f MW/line', P1);
+printf('\nLines required to transmit 9000 MW power with 345 kV line out of service is = %0.0f', line1);
+
+printf('\n\nSurge Impedance Load for line 2 is = %0.0f MW', SIL2);
+printf('\nReal power delivered for line 2 without losses is = %0.0f MW/line', P2);
+printf('\nLines required to transmit 9000 MW power with 500 kV line out of service is = %0.0f', line2);
+
+printf('\n\n Surge Impedance Load for line 3 is = %0.0f MW', SIL3);
+printf('\nReal power delivered for line 3 without losses is = %0.0f MW/line', P3);
+printf('\nLines required to transmit 9000 MW power with 765 kV line out of service is = %0.0f', line3);
diff --git a/3872/CH5/EX5.8/Ex5_8.JPG b/3872/CH5/EX5.8/Ex5_8.JPG Binary files differnew file mode 100644 index 000000000..7f44d7d33 --- /dev/null +++ b/3872/CH5/EX5.8/Ex5_8.JPG diff --git a/3872/CH5/EX5.8/Ex5_8.sce b/3872/CH5/EX5.8/Ex5_8.sce new file mode 100644 index 000000000..893eeccbc --- /dev/null +++ b/3872/CH5/EX5.8/Ex5_8.sce @@ -0,0 +1,29 @@ +// Book - Power System: Analysis & Design 5th Edition
+// Authors - J. Duncan Glover, Mulukutla S. Sharma, Thomas J. Overbye
+// Chapter - 5 : Example 5.8
+// Scilab Version 6.0.0 : OS - Windows
+
+clc;
+clear;
+
+N = 6; // Number of transmission lines
+Vs = 765; // Transmission voltage in kV
+l = 167; // Intermediate substations distance in km
+Pl=9000; //Load power , value taken from Example 5.7
+lambda = 5000; // Wavelength in km
+Beta = (2*%pi)/lambda; // Taken from Eq 5.4.15
+L = 500; // Eqivalent pi circuit lenght in km
+Zc = 266; // Characteristic impedance of the line in Ohm
+X = Zc*sin(Beta*L); // Series reactance in Ohm ; taken from Eq 5.4.10
+Xeq = ((1/5)*((2/3)*X))+((1/4)*(X/3)); // Equivalent reactance of five lines with one line section out of service in Ohm
+Vr = 0.95*765; // Receiving end voltage in kV
+delta = 35; // Phase angle in degree
+P = ((Vs*Vr)/Xeq)*sind(delta); // Real power delivered in MW ; taken from Eq 5.4.26
+
+printf('Series reactance is (X) = %0.2f Ohm', X);
+printf('\nEquivalent reactance of five lines with one line section out of service is (Xeq) = %0.2f Ohm', Xeq);
+printf('\nReal power delivered is (P) = %0.0f MW', P);
+
+if 0.97*P>Pl //Assuming 3% as losses
+ printf('\n\nThe five instead of six 765-kV lines can transmit the required power in Example 5.7')
+end
diff --git a/3872/CH5/EX5.9/Ex5_9.JPG b/3872/CH5/EX5.9/Ex5_9.JPG Binary files differnew file mode 100644 index 000000000..91ffc8399 --- /dev/null +++ b/3872/CH5/EX5.9/Ex5_9.JPG diff --git a/3872/CH5/EX5.9/Ex5_9.sce b/3872/CH5/EX5.9/Ex5_9.sce new file mode 100644 index 000000000..e345d216f --- /dev/null +++ b/3872/CH5/EX5.9/Ex5_9.sce @@ -0,0 +1,36 @@ +// Book - Power System: Analysis & Design 5th Edition
+// Authors - J. Duncan Glover, Mulukutla S. Sharma, Thomas J. Overbye
+// Chapter - 5 : Example 5.9
+// Scilab Version 6.0.0 : OS - Windows
+
+clc;
+clear;
+
+l = 300; // line lenght in km
+If = 1.90; // Full load current in kA
+pf = 1; // Power Factor
+VF = 730; // Voltage in kV
+V = 730/sqrt(3); // Line voltage in kV
+
+Irfl = 1.9*exp(%i*0*%pi/180); // Full load receiving end current in kA
+Vrfl = V*exp(%i*0*%pi/180); // Full load receiving end voltage in kV
+A = 0.9313*exp(%i*0.209*%pi/180); // Line parameter value in per unit ; taken from Ex 5.2
+B = 97.0*exp(%i*87.20*%pi/180); // Line parameter value in Ohm ; taken from Ex 5.2
+VsLN = (A*Vrfl)+(B*Irfl);
+VsLL = abs(VsLN)*sqrt(3); // Sending end voltage in kVLN
+Vrnl = VsLL/abs(A); // No load Receiving end Voltage in kVLL
+PercentVR1 = ((Vrnl - VF)/VF)*100; // Percent voltage regulation for the uncompensated line in Percent
+
+Y = 2*(3.7*10^-7+%i*7.094*10^-4); // Shunt admitance of a Eqivalent pi circuit in Siemens ; taken from Ex 5.3
+Yeq = real(Y)+%i*imag(Y)*(1-(75/100)); // Equivalent shunt admitance in Siemens
+Zeq = B; // Eqivalent series impedance in Ohm
+
+Aeq = 1+((Yeq*Zeq)/2); // The eqivalent A parameter for the compensated line in per unit
+VRNL = VsLL/abs(Aeq); // No load Receiving end Voltage in kVLL
+PercentVR2 = ((VRNL - VF)/VF)*100; // Percent voltage regulation for the uncompensated line in Percent
+
+
+printf('Percent voltage regulation for the uncompensated line is (PercentVR1) = %0.2f Percent', PercentVR1)
+printf('\nEquivalent shunt admitance in Siemens is (Yeq) : %0.3e and its angle is : %0.2f degree', abs(Yeq), atand(imag(Yeq), real(Yeq)));
+printf('\nEqivalent series impedance in Ohm is (Zeq) : %0.1f and its angle is : %0.1f degree', abs(Zeq), atand(imag(Zeq), real(Zeq)));
+printf('\nPercent voltage regulation for the uncompensated line is (PercentVR2) = %0.2f Percent', PercentVR2)
|