diff options
author | priyanka | 2015-06-24 15:03:17 +0530 |
---|---|---|
committer | priyanka | 2015-06-24 15:03:17 +0530 |
commit | b1f5c3f8d6671b4331cef1dcebdf63b7a43a3a2b (patch) | |
tree | ab291cffc65280e58ac82470ba63fbcca7805165 /3035/CH4 | |
download | Scilab-TBC-Uploads-b1f5c3f8d6671b4331cef1dcebdf63b7a43a3a2b.tar.gz Scilab-TBC-Uploads-b1f5c3f8d6671b4331cef1dcebdf63b7a43a3a2b.tar.bz2 Scilab-TBC-Uploads-b1f5c3f8d6671b4331cef1dcebdf63b7a43a3a2b.zip |
initial commit / add all books
Diffstat (limited to '3035/CH4')
-rwxr-xr-x | 3035/CH4/EX4.1/Ex4_1.sce | 19 | ||||
-rwxr-xr-x | 3035/CH4/EX4.10/Ex4_10.sce | 11 | ||||
-rwxr-xr-x | 3035/CH4/EX4.11/Ex4_11.sce | 16 | ||||
-rwxr-xr-x | 3035/CH4/EX4.12/Ex4_12.sce | 47 | ||||
-rwxr-xr-x | 3035/CH4/EX4.13/Ex4_13.sce | 27 | ||||
-rwxr-xr-x | 3035/CH4/EX4.14/Ex4_14.sce | 104 | ||||
-rwxr-xr-x | 3035/CH4/EX4.16/Ex4_16.sce | 28 | ||||
-rwxr-xr-x | 3035/CH4/EX4.17/Ex4_17.sce | 28 | ||||
-rwxr-xr-x | 3035/CH4/EX4.18/Ex4_18.sce | 34 | ||||
-rwxr-xr-x | 3035/CH4/EX4.19/Ex4_19.sce | 30 | ||||
-rwxr-xr-x | 3035/CH4/EX4.2/Ex4_2.sce | 10 | ||||
-rwxr-xr-x | 3035/CH4/EX4.3/Ex4_3.sce | 14 | ||||
-rwxr-xr-x | 3035/CH4/EX4.4/Ex4_4.sce | 28 | ||||
-rwxr-xr-x | 3035/CH4/EX4.5/Ex4_5.sce | 29 | ||||
-rwxr-xr-x | 3035/CH4/EX4.6/Ex4_6.sce | 32 | ||||
-rwxr-xr-x | 3035/CH4/EX4.7/Ex4_7.sce | 15 | ||||
-rwxr-xr-x | 3035/CH4/EX4.8/Ex4_8.sce | 28 | ||||
-rwxr-xr-x | 3035/CH4/EX4.9/Ex4_9.sce | 14 |
18 files changed, 514 insertions, 0 deletions
diff --git a/3035/CH4/EX4.1/Ex4_1.sce b/3035/CH4/EX4.1/Ex4_1.sce new file mode 100755 index 000000000..e36dc8d13 --- /dev/null +++ b/3035/CH4/EX4.1/Ex4_1.sce @@ -0,0 +1,19 @@ + +// Variable Declaration +l = 10.0 //Length of 1-phase line(km) +d = 100.0 //Spacing b/w conductors(cm) +r = 0.3 //Radius(cm) +u_r_1 = 1.0 //Relative permeability of copper +u_r_2 = 100.0 //Relative permeability of steel + +// Calculation Section +r_1 = 0.7788*r //Radius of hypothetical conductor(cm) +L_1 = 4 * 10**(-7) * log(d/r_1) //Loop inductance(H/m) +L_T1 = L_1 * l * 10**6 //Total loop inductance(mH) + +L_2 = 4 * 10**(-7) * (log(d/r) + (u_r_2/4))//Loop inductance(H/m) +L_T2 = L_2 * l * 10**6 //Total loop inductance(mH) + +// Result Section +printf('(i) Total loop inductance of copper conductor = %.2f mH' ,L_T1) +printf('(ii)Total loop inductance of steel conductor = %.2f mH' ,L_T2) diff --git a/3035/CH4/EX4.10/Ex4_10.sce b/3035/CH4/EX4.10/Ex4_10.sce new file mode 100755 index 000000000..b7643bd1d --- /dev/null +++ b/3035/CH4/EX4.10/Ex4_10.sce @@ -0,0 +1,11 @@ + + +// calculation of GMD , Dm +// Dab = (da1b1 * da1b2 * da2b1 * da2b2)*(1/4) = (gkkg)^(1/2) = sqrt(gk) +// Inductance/phase = 2 * 10^-7 log ( Dm / Ds) + +printf("Inductance/phase = 2 * 10^-7 / 3 * log(g^2*k^2*h*d/(r^3*f^2*m)) H/m") + +// Capacitance/phase = 2*%pi*%e/( log(Dm/Ds)) + +disp("Capacitance/phase = 6*%pi*%e / (log(g^2*k^2*h*d/(r^3*f^2*m))) F/m") diff --git a/3035/CH4/EX4.11/Ex4_11.sce b/3035/CH4/EX4.11/Ex4_11.sce new file mode 100755 index 000000000..389ae6129 --- /dev/null +++ b/3035/CH4/EX4.11/Ex4_11.sce @@ -0,0 +1,16 @@ + +// Variable Declaration +h = 5 //Height of conductor above ground(m) +d = 1.5 //Conductor spacing(m) +r = 0.006 //Radius of conductor(m) + +// Calculation Section +C_AB = %pi * 8.854*10**-9/log(d/(r*(1+((d*d)/(4*h*h)))**0.5)) //Capacitance with effect of earth(F/km) +C_AB1 = %pi * 8.854*10**-9/log(d/r) //Capacitance ignoring effect of earth(F/km) +ch = (C_AB - C_AB1)/C_AB * 100 //Change in capacitance with effect of earth(%) + + +// Result Section +printf('Line capacitance with effect of earth , C_AB = %.3e F/km' ,C_AB) +printf('Line capacitance ignoring effect of earth , C_AB = %.3e F/km' ,C_AB1) +printf('With effect of earth slight increase in capacitance = %.1f percent' ,ch) diff --git a/3035/CH4/EX4.12/Ex4_12.sce b/3035/CH4/EX4.12/Ex4_12.sce new file mode 100755 index 000000000..960dd8d18 --- /dev/null +++ b/3035/CH4/EX4.12/Ex4_12.sce @@ -0,0 +1,47 @@ + +// Variable Declaration +R = 0.16 //Resistance(ohm) +L = 1.26*10**(-3) //Inductance(H) +C = 8.77*10**(-9) //Capacitance(F) +l = 200.0 //Length of line(km) +P = 50.0 //Power(MVA) +pf = 0.8 //Lagging power factor +V_r = 132000.0 //Receiving end voltage(V) +f = 50.0 //Frequency(Hz) + +// Calculation Section +w = 2 * %pi * f +z = complex(R, w*L) //Series impedance per phase per km(ohm) +y = complex(0, w*C) //Shunt admittance per phase per km(mho) + +g = (y*z)**(0.5) //propagation constant(/km) +gl = g * l +Z_c = (z/y)**(0.5) //Surge impedance(ohm) + +cosh_gl = cosh(gl) +sinh_gl = sinh(gl) + +A = cosh_gl +B = Z_c * sinh_gl +C = (sinh_gl/Z_c) +D = cosh_gl + +fi = acos(pf) //Power factor angle(radians) +V_R = V_r/(3**0.5) //Receiving end voltage(V) +I_R = (P*10**6/((3**0.5)*V_r))*(pf - complex(0,sin(fi)))//Receiving end current(A) +V_S = (A*V_R + B*I_R) //Sending end voltage(V/phase) +V_S_L = V_S * (3**0.5)*10**-3 //Sending end line voltage(kV) +I_S = C*V_R + D*I_R //Sending end current(A) +pf_S = cos((phasemag(I_S)*%pi/180) - (phasemag(V_S)*%pi/180)) //Sending end power factor +P_S = abs(V_S*I_S)*pf_S*10**-6 //Sending end power/phase(MW) +P_R = (P/3)*pf //Receiving end power/phase(MW) +P_L = 3*(P_S - P_R) //Total line loss(MW) + + +// Result Section +printf('Sending end voltage , V_S = %.2f∠%.2f° kV/phase' ,abs(V_S*10**-3),phasemag(V_S)) +printf('Sending end line voltage = %.2f kV' ,abs(V_S_L)) +printf('Sending end current , I_S = %.2f∠%.2f° A' ,abs(I_S),phasemag(I_S)) +printf('Sending end power factor = %.2f lagging' ,pf_S) +printf('Total transmission line loss = %.3f MW' ,P_L) +printf('NOTE : Answers are slightly different because of rounding error.') diff --git a/3035/CH4/EX4.13/Ex4_13.sce b/3035/CH4/EX4.13/Ex4_13.sce new file mode 100755 index 000000000..fd5a300c0 --- /dev/null +++ b/3035/CH4/EX4.13/Ex4_13.sce @@ -0,0 +1,27 @@ + +// Variable Declaration +R = 0.1 //Resistance/phase/km(ohm) +D_m = 800.0 //Spacing b/w conductors(cm) +d = 1.5 //Diameter of each conductor(cm) +l = 300.0 //Length of transmission line(km) +f = 50.0 //Frequency(Hz) + +// Calculation Section +L = 2*10**(-4)*log(D_m*2/d) //Inductance/phase/km(H) +C = 2*%pi*8.854*10**(-9)/log(D_m*2/d) //Capacitance/phase/km(F) +w = 2 * %pi * f +z = complex(R, w*L) //Series impedance per phase per km(ohm/km) +y = complex(0, w*C) //Shunt admittance per phase per km(mho/km) +g = (y*z)**(0.5) //propagation constant(/km) +gl = g * l +Z_c = (z/y)**(0.5) //Surge impedance(ohm) +sinh_gl = sinh(gl) +tanh_gl = tanh(gl/2) +Z_S = Z_c * sinh_gl //Series impedance(ohm) +Y_P = (1/Z_c)*tanh(gl/2) //Pillar admittance(mho) + +// Result Section +printf('Values of equivalent-pi network are :') +printf('Series impedance , Z_S = (%.2f + j%.2f) ohm' ,real(Z_S),imag(Z_S)) +printf('Pillar admittance , Y_P = %.2e∠%.2f° mho = j%.2e mho' ,abs(Y_P),phasemag(Y_P),imag(Y_P)) +printf('NOTE : Answers are slightly different because of rounding error.') diff --git a/3035/CH4/EX4.14/Ex4_14.sce b/3035/CH4/EX4.14/Ex4_14.sce new file mode 100755 index 000000000..b7248a223 --- /dev/null +++ b/3035/CH4/EX4.14/Ex4_14.sce @@ -0,0 +1,104 @@ + +// Variable Declaration +V_r = 220000.0 //Voltage(V) +P = 100.0 //Power(MW) +r = 0.08 //Series resistance(ohm) +x = 0.8 //Series reactance(ohm) +s = 6.0*10**(-6) //Shunt susceptance(mho) +pf = 0.8 //Power factor lagging +l_1 = 60.0 //Transmission length(km) for case(i) +l_2 = 200.0 //Transmission length(km) for case(ii) +l_3 = 300.0 //Transmission length(km) for case(iii) +l_4 = 500.0 //Transmission length(km) for case(iv) + +// Calculation Section +z = complex(r,x) //Series impedance/km(ohm) +y = complex(0,s) //Shunt admittance/km(mho) +theta_R = acos(pf) +P_R = P/3 //Active power at receiving end/phase(MW) +Q_R = (P/3)*tan(theta_R) //Reactive power at receiving end/phase(MVAR) +V_R = V_r/(3**0.5) //Receiving end voltage/phase(V) +I_R = P*10**6/((3**0.5)*V_r*pf)*(pf - complex(0,sin(theta_R)))//Receiving end current(A) +Z_c = (z/y)**(0.5) //Surge impedance(ohm) + +A_1 = 1 //Constant A +B_1 = z*l_1 //Constant B(ohm) +C_1 = 0 //Constant C(mho) +D_1 = A_1 //Constant D +V_S_1 = A_1*V_R + B_1*I_R //Sending end voltage(V/phase) +I_S_1 = I_R //Sending end current(A) +theta_S_1 = (phasemag(I_S_1)*%pi/180) - (phasemag(V_S_1)*%pi/180) //Sending end power factor +P_S_1 = abs(V_S_1*I_S_1)*cos(theta_S_1)*10**-6 //Sending end power(MW) +n_1 = (P_R/P_S_1)*100 //Transmission efficiency(%) +reg_1 = (abs(V_S_1/A_1) - V_R)/V_R*100 //Regulation(%) +Q_S_1 = V_S_1 * conj(I_S_1)*10**-6 //Sending end reactive power(MVAR) +Q_line_1 = imag(Q_S_1) - Q_R //Reactive power absorbed by line(MVAR) + +Z_S_2 = z*l_2 +Y_P_2 = y*l_2/2 +A_2 = 1 + Y_P_2*Z_S_2 +B_2 = Z_S_2 +C_2 = Y_P_2*(2 + Y_P_2*Z_S_2) +D_2 = A_2 +V_S_2 = A_2*V_R + B_2*I_R //Sending end voltage(V/phase) +I_S_2 = C_2*V_R + D_2*I_R //Sending end current(A) +S_S_2 = V_S_2*conj(I_S_2)*10**-6 //Sending end complex power(MVA) +P_S_2 = real(S_S_2) //Power at sending end(MW) +n_2 = (P_R/P_S_2)*100 //Transmission efficiency(%) +reg_2 = (abs(V_S_2/A_2) - V_R)/V_R*100 //Regulation(%) +Q_line_2 = imag(S_S_2) - Q_R //Reactive power absorbed by line(MVAR) + +g_3 = (y*z)**(0.5) //propagation constant(/km) +gl_3 = g_3 * l_3 +cosh_gl_3 = cosh(gl_3) +sinh_gl_3 = sinh(gl_3) +A_3 = cosh_gl_3 +B_3 = Z_c * sinh_gl_3 +C_3 = sinh_gl_3/Z_c +D_3 = cosh_gl_3 +V_S_3 = A_3*V_R + B_3*I_R //Sending end voltage(V/phase) +I_S_3 = C_3*V_R + D_3*I_R //Sending end current(A) +S_S_3 = V_S_3*conj(I_S_3)*10**-6 //Sending end complex power(MVA) +P_S_3 = real(S_S_3) //Power at sending end(MW) +n_3 = (P_R/P_S_3)*100 //Transmission efficiency(%) +reg_3 = (abs(V_S_3/A_3) - V_R)/V_R*100 //Regulation(%) +Q_line_3 = imag(S_S_3) - Q_R //Reactive power absorbed by line(MVAR) + +g_4 = (y*z)**(0.5) //propagation constant(/km) +gl_4 = g_4 * l_4 +cosh_gl_4 = cosh(gl_4) +sinh_gl_4 = sinh(gl_4) +A_4 = cosh_gl_4 +B_4 = Z_c * sinh_gl_4 +C_4 = sinh_gl_4/Z_c +D_4 = cosh_gl_4 +V_S_4 = A_4*V_R + B_4*I_R //Sending end voltage(V/phase) +I_S_4 = C_4*V_R + D_4*I_R //Sending end current(A) +S_S_4 = V_S_4*conj(I_S_4)*10**-6 //Sending end complex power(MVA) +P_S_4 = real(S_S_4) //Power at sending end(MW) +n_4 = (P_R/P_S_4)*100 //Transmission efficiency(%) +reg_4 = (abs(V_S_4/A_4) - V_R)/V_R*100 //Regulation(%) +Q_line_4 = imag(S_S_4) - Q_R //Reactive power absorbed by line(MVAR) + +// Result Section +printf('Case(i) : For Length = 60 km') +printf('Efficiency , n = %.2f percent' ,n_1) +printf('Regulation = %.3f percent' ,reg_1) +printf('Reactive power at sending end , Q_S = %.2f MVAR' ,imag(Q_S_1)) +printf('Reactive power absorbed by line , Q_line = %.2f MVAR' ,Q_line_1) +printf('\nCase(ii) : For Length = 200 km') +printf('Efficiency , n = %.2f percent' ,n_2) +printf('Regulation = %.2f percent' ,reg_2) +printf('Reactive power at sending end , Q_S = %.2f MVAR' ,imag(S_S_2)) +printf('Reactive power absorbed by line , Q_line = %.2f MVAR' ,Q_line_2) +printf('\nCase(iii) : For Length = 300 km') +printf('Efficiency , n = %.2f percent' ,n_3) +printf('Regulation = %.2f percent' ,reg_3) +printf('Reactive power at sending end , Q_S = %.2f MVAR' ,imag(S_S_3)) +printf('Reactive power absorbed by line , Q_line = %.2f MVAR' ,Q_line_3) +printf('\nCase(iv) : For Length = 500 km') +printf('Efficiency , n = %.2f percent' ,n_4) +printf('Regulation = %.2f percent' ,reg_4) +printf('Reactive power at sending end , Q_S = %.2f MVAR' ,imag(S_S_4)) +printf('Reactive power absorbed by line , Q_line = %.2f MVAR' ,Q_line_4) +printf('\nNOTE : ERROR : Calculation mistake in case(iv) efficiency in textbook') diff --git a/3035/CH4/EX4.16/Ex4_16.sce b/3035/CH4/EX4.16/Ex4_16.sce new file mode 100755 index 000000000..8202bc733 --- /dev/null +++ b/3035/CH4/EX4.16/Ex4_16.sce @@ -0,0 +1,28 @@ + +// Variable Declaration +A = 0.8*exp(%i*1.4*%pi/180) //Line constant +B = 326.0*exp(%i*84.8*%pi/180) //Line constant(ohm) +V_R = 220.0 //Receiving end voltage(kV) +V_S = 220.0 //Sending end voltage(kV) +P = 75.0 //Power(MVA) for case(a) +pf = 0.8 //Power factor lagging + +a = phasemag(A)*%pi/180 //Phase angle of A(radian) +b = phasemag(B)*%pi/180 //Phase angle of B(radian) + +// Calculation Section +P_R = P * pf //Active power demanded by load(MW) +P_React = P *(1-pf**2)**0.5 //Reactive power demanded by load(MVAR) +cos_b_delta_1 = P_R*abs(B)/(V_R*V_S) + abs(A)*cos(b-a) //cos(b-delta)[in radians] +delta_1 = b - acos(cos_b_delta_1) //delta(radians) +Q_R_1 = (V_R*V_S/abs(B))*sin(b-delta_1) - (abs(A)*V_R**2/abs(B))*sin(b-a) //Reactive power at sending end(MVAR) +Reactive_power_1 = P_React - Q_R_1 //Reactive power to be supplied by compensating equipment(MVAR) + +cos_b_delta_2 = (abs(A)*V_R/V_S)*cos(b-a) //cos(b-delta)[in radians] +delta_2 = b - acos(cos_b_delta_2) //delta(radians) +Q_R_2 = (V_R*V_S/abs(B))*sin(b-delta_2) - (abs(A)*V_R**2/abs(B))*sin(b-a) //Reactive power at sending end(MVAR) +Reactive_power_2 = Q_R_2 //Reactive power to be absorbed by compensating equipment(MVAR) + +// Result Section +printf('(a) Reactive VARs to be supplied by compensating equipment = %.2f MVAR' ,Reactive_power_1) +printf('(b) Reactive VARs to be absorbed by compensating equipment = %.2f MVAR' ,Reactive_power_2) diff --git a/3035/CH4/EX4.17/Ex4_17.sce b/3035/CH4/EX4.17/Ex4_17.sce new file mode 100755 index 000000000..66cbdc538 --- /dev/null +++ b/3035/CH4/EX4.17/Ex4_17.sce @@ -0,0 +1,28 @@ + +// Variable Declaration +r = 25.0 //Resistance/phase(ohm) +x = 90.0 //Reactance/phase(ohm) +V_S = 145.0 //Sending end voltage(kV) +V_R = 132.0 //Receiving end voltage(kV) +P_R_1 = 0 //Power(MW) +P_R_2 = 50.0 //Power(MW) + +// Calculation Section +A = 1.0*exp(%i*0*%pi/180) //Line constant +B = complex(r,x) //Line constant(ohm) +a = phasemag(A)*%pi/180 //Phase angle of A(radian) +b = phasemag(B)*%pi/180 //Phase angle of B(radian) + +cos_b_delta_1 = (V_R/V_S)*cos(b-a) +delta_1 = b - acos(cos_b_delta_1) +Q_R_1 = (V_R*V_S/abs(B))*sin(b-delta_1) - (abs(A)*V_R**2/abs(B))*sin(b-a) + +cos_b_delta_2 = (P_R_2*abs(B)/(V_R*V_S))+(abs(A)*V_R/V_S)*cos(b-a) +delta_2 = (b - acos(cos_b_delta_2)) +Q_R_2 = (V_R*V_S/abs(B))*sin(b-delta_2)-(abs(A)*V_R**2/abs(B))*sin(b-a) //Reactive power available at receiving end(MVAR) +Q_S_2 = Q_R_1 + Q_R_2 //Reactive power to be supplied by equipment(MVAR) +pf = cos(atan(Q_S_2/P_R_2)) //Power factor + +// Result Section +printf('Rating of device = %.2f MVAR' ,Q_R_1) +printf('Power factor = %.2f lagging' ,pf) diff --git a/3035/CH4/EX4.18/Ex4_18.sce b/3035/CH4/EX4.18/Ex4_18.sce new file mode 100755 index 000000000..9adde50f3 --- /dev/null +++ b/3035/CH4/EX4.18/Ex4_18.sce @@ -0,0 +1,34 @@ + +// Variable Declaration +A = 0.9*exp(%i*1.0*%pi/180) //Line constant +B = 143.0*exp(%i*84.5*%pi/180) //Line constant(ohm) +V_R = 220.0 //Receiving end voltage(kV) +V_S = 240.0 //Sending end voltage(kV) +P = 100.0 //Power(MVA) +pf = 0.8 //Power factor lagging + +a = phasemag(A)*%pi/180 //Phase angle of A(radian) +b = phasemag(B)*%pi/180 //Phase angle of B(radian) + +// Calculation Section +P_R = P * pf //Active power at receiving end(MW) +cos_b_delta = (P_R*abs(B)/(V_R*V_S))+(abs(A)*V_R/V_S)*cos(b-a) //cos(b-delta)[in radians] +delta_1 = (b - acos(cos_b_delta)) +Q_R = (V_R*V_S/abs(B))*sin(b-delta_1)-(abs(A)*V_R**2/abs(B))*sin(b-a) //Reactive power at receiving end(MVAR) +P_Re = P *(1-pf**2)**0.5 //Reactive power(MVAR) +rating = P_Re - Q_R //Rating of phase modifier(MVAR) + +delta_2 = b //Maximum power is received when delta = b +P_Rmax = (V_R*V_S/abs(B))-(abs(A)*V_R**2/abs(B))*cos(b-a) //Maximum power at receiving end(MW) +Q_R = -(abs(A/B)*V_R**2)*sin(b-a) //Reactive power at receive end(MVAR) +P_S = (V_S**2*abs(A/B))*cos(b-a)-(V_S*V_R/abs(B))*cos(b+delta_2) //Sending end power(MW) +n_line = (P_Rmax/P_S)*100 //Line efficiency(%) + +// Result Section +printf('Case(a) :') +printf('Rating of phase modifier = %.3f MVAR' ,rating) +printf('Power angle , delta = %.2f°' ,(delta_1*180/%pi)) +printf('\nCase(b) :') +printf('Maximum power at receive end , P_Rmax = %.2f MW' ,P_Rmax) +printf('Reactive power available , Q_R = %.2f MVAR' ,Q_R) +printf('Line efficiency = %.2f percent' ,n_line) diff --git a/3035/CH4/EX4.19/Ex4_19.sce b/3035/CH4/EX4.19/Ex4_19.sce new file mode 100755 index 000000000..41853d6d5 --- /dev/null +++ b/3035/CH4/EX4.19/Ex4_19.sce @@ -0,0 +1,30 @@ + +// Variable Declaration +A = 0.96*exp(%i*1.0*%pi/180) //Line constant +B = 100.0*exp(%i*83.0*%pi/180) //Line constant(ohm) +V_R = 110.0 //Receiving end voltage(kV) +V_S = 110.0 //Sending end voltage(kV) +pf = 0.8 //Power factor lagging +delta = 15*%pi/180 //Power angle(radians) + +// Calculation Section +a = phasemag(A)*%pi/180 //Phase angle of A(radian) +b = phasemag(B)*%pi/180 //Phase angle of B(radian) + +P_R = (V_R*V_S/abs(B))*cos(b-delta) - (abs(A/B)*V_R**2)*cos(b-a) //Active power at receiving end(MW) +Q_RL = P_R*tan(acos(pf)) //Reactive power demanded by load(MVAR) + +Q_R = (V_R*V_S/abs(B))*sin(b-delta) - (abs(A/B)*V_R**2)*sin(b-a) //Reactive power(MVAR) +rating = Q_RL - Q_R //Rating of device(MVAR) + +P_S = (V_S**2*abs(A/B))*cos(b-a) - (V_R*V_S/abs(B))*cos(b+delta) //Sending end active power(MW) +n_line = (P_R/P_S)*100 //Efficiency of line(%) + +Q_S = (V_S**2*abs(A/B))*sin(b-a) - (V_R*V_S/abs(B))*sin(b+delta) //Sending end reactive power(MVAR) + +// Result Section +printf('(i) Active power demanded by load , P_R = %.2f MW' ,P_R) +printf(' Reactive power demanded by load , Q_RL = %.2f MVAR' ,Q_RL) +printf('(ii) Rating of the device , Q_R = %.2f MVAR' ,rating) +printf('(iii)Efficiency of line = %.2f percent' ,n_line) +printf('(iv) Reactive power supplied by source and line , Q_S = %.2f MVAR' ,Q_S) diff --git a/3035/CH4/EX4.2/Ex4_2.sce b/3035/CH4/EX4.2/Ex4_2.sce new file mode 100755 index 000000000..15eee1f0f --- /dev/null +++ b/3035/CH4/EX4.2/Ex4_2.sce @@ -0,0 +1,10 @@ +// Variable Declaration +r = 0.4 //Radius of conductor(cm) +h = 1000 //Height of line(cm) + +// Calculation Section +d = 2*h //Spacing between conductors(cm) +L = 2 * 10**(-4) * log(2*h/(0.7788*r)) * 1000 //Inductance of conductor(mH/km) + +// Result Section +printf('Inductance of the conductor = %.3f mH/km' ,L) diff --git a/3035/CH4/EX4.3/Ex4_3.sce b/3035/CH4/EX4.3/Ex4_3.sce new file mode 100755 index 000000000..6634e89ad --- /dev/null +++ b/3035/CH4/EX4.3/Ex4_3.sce @@ -0,0 +1,14 @@ + +// Variable Declaration +d_ab = 4 //Distance b/w conductor a & b(m) +d_bc = 9 //Distance b/w conductor b & c(m) +d_ca = 6 //Distance b/w conductor c & a(m) +r = 1.0 //Radius of each conductor(cm) + +// Calculation Section +D_m = (d_ab * d_bc * d_ca)**(1.0/3) //Geometric mean separation(m) +r_1 = 0.7788 * (r/100) //Radius of hypothetical conductor(m) +L = 2 * 10**(-7) * log(D_m/r_1) * 10**6 //Line inductance(mH/phase/km) + +// Result Section +printf('Line inductance , L = %.2f mH/phase/km' ,L) diff --git a/3035/CH4/EX4.4/Ex4_4.sce b/3035/CH4/EX4.4/Ex4_4.sce new file mode 100755 index 000000000..9c7117749 --- /dev/null +++ b/3035/CH4/EX4.4/Ex4_4.sce @@ -0,0 +1,28 @@ + +// Variable Declaration +r = 1.0 //Radius of each conductor(cm) +d_11 = 30 //Distance b/w conductor 1 & 1'(cm) +d_22 = 30 //Distance b/w conductor 2 & 2'(cm) +d_12 = 130 //Distance b/w conductor 1 & 2(cm) +d_122 = 160 //Distance b/w conductor 1 & 2'(cm) +d_112 = 100 //Distance b/w conductor 1' & 2(cm) +d_1122 = 130 //Distance b/w conductor 1' & 2'(cm) + +// Calculation Section +r_1 = 0.7788 * r //Radius of hypothetical conductor(cm) +D_s = (d_11 * r_1 * d_22 * r_1)**(1.0/4) //Geometric mean radius(cm) +D_m = (d_12 * d_122 * d_112 * d_1122)**(1.0/4) //Geometric mean separation(cm) +L = 4 * 10**(-7) * log(D_m/D_s) * 10**6 //Loop inductance(mH/km) + +R = 2**0.5 //Radius of single conductor(cm) +d = 130.0 //Conductor position(cm) +L_1 = 4*10**(-7)*log(d/(0.7788*R))*10**6 //Loop inductance(mH/km) +L_diff = (L_1 - L)/L*100 //Change in inductance(%) +r_diff = D_s - R //Effective radius difference + + +// Result Section +printf('Loop inductance , L = %.3f mH/km' ,L) +printf('Loop inductance having two conductors only , L = %.3f mH/km' ,L_1) +printf('There is an Increase of %.f percent in inductance value ' ,L_diff) +printf('Effective radius of bundled conductors is about %.1f times that of unbundled system reducing field stress almost by that ratio' ,r_diff) diff --git a/3035/CH4/EX4.5/Ex4_5.sce b/3035/CH4/EX4.5/Ex4_5.sce new file mode 100755 index 000000000..8ca1a121e --- /dev/null +++ b/3035/CH4/EX4.5/Ex4_5.sce @@ -0,0 +1,29 @@ + +// Variable Declaration +r = 1.5 //Radius of each conductor(cm) +D_a1a2 = 0.3 //Distance b/w conductor a1 & a2(m) +D_a2a1 = 0.3 //Distance b/w conductor a2 & a1(m) +D_a1b1 = 15.3 //Distance b/w conductor a1 & b1(m) +D_a1b2 = 15.6 //Distance b/w conductor a1 & b2(m) +D_a2b1 = 15.0 //Distance b/w conductor a2 & b1(m) +D_a2b2 = 15.3 //Distance b/w conductor a2 & b2(m) +D_b1c1 = 15.3 //Distance b/w conductor b1 & c1(m) +D_b1c2 = 15.6 //Distance b/w conductor b1 & c2(m) +D_b2c1 = 15.0 //Distance b/w conductor b2 & c1(m) +D_b2c2 = 15.3 //Distance b/w conductor b2 & c2(m) +D_a1c1 = 30.6 //Distance b/w conductor a1 & c1(m) +D_a1c2 = 30.9 //Distance b/w conductor a1 & c2(m) +D_a2c1 = 30.3 //Distance b/w conductor a2 & c1(m) +D_a2c2 = 30.6 //Distance b/w conductor a2 & c2(m) + +// Calculation Section +r_1 = 0.7788 * (r/100) //Radius of hypothetical conductor(m) +D_s = (D_a1a2 * r_1 * D_a2a1 * r_1)**(1.0/4) //Geometric mean radius(m) +D_ab = (D_a1b1 * D_a1b2 * D_a2b1 * D_a2b2)**(1.0/4) //Mutual GMD b/w conductor a & b(m) +D_bc = (D_b1c1 * D_b1c2 * D_b2c1 * D_b2c2)**(1.0/4) //Mutual GMD b/w conductor b & c(m) +D_ca = (D_a1c1 * D_a1c2 * D_a2c1 * D_a2c2)**(1.0/4) //Mutual GMD b/w conductor c & a(m) +D_m = (D_ab * D_bc * D_ca)**(1.0/3) //Geometric mean separation(m) +L = 2 * 10**(-4) * log(D_m/D_s) * 1000 //Inductance(mH/km) + +// Result Section +printf('Inductance/phase/km = %.3f mH/km' ,L) diff --git a/3035/CH4/EX4.6/Ex4_6.sce b/3035/CH4/EX4.6/Ex4_6.sce new file mode 100755 index 000000000..672f32d86 --- /dev/null +++ b/3035/CH4/EX4.6/Ex4_6.sce @@ -0,0 +1,32 @@ + +// part - I +// Dsa = GMR of phase a in section - I +// (r'Da1a2)(Da1a2r')^(1/4) = sqrt(r'Da1a2) +// Da1a2 = sqrt(D^2 + 4d^2) +printf(" Dsa = sqrt(r * sqrt(D^2 + 4*d^2))") + +// Dsb = GMR of phase b in section - II +// Dsb = sqrt(r * Db1b2) +// Db1b2 = D + +printf(" Dsb = sqrt(rD) ") + +// Dsc = GMR of phase c in section - I +// = sqrt(r'Dc1c2) +// Dc1c2 = sqrt(D^2 + rd^2) +printf(" Dsc = sqrt(r * sqrt(D^2 + 4*d^2))") + +// part - II +// Dab = Mutual GMD between phase a and b in section I of the trasportation cycle. + +printf(" Dab = sqrt(d * sqrt(d^2 + D^2))") +printf(" Dbc = sqrt(d * sqrt(d^2 + D^2))") +printf(" Dca = sqrt(2d * D)") + +// part - III +// GMD for fictitious equilateral spacing + +printf ( " Ds = (r)^(1/2) * (D^2 * 4d^2)^(1/6)*D^(1/6)") +// so the inductance per phase is, + +printf(" L = 2 * 10^-4 * log((2^(1/6)*(D^2+d^2)^(1/6) * d^(1/2))/(r^(1/2) * (D^2 + 4d^2)^(1/6))) H/km" ) diff --git a/3035/CH4/EX4.7/Ex4_7.sce b/3035/CH4/EX4.7/Ex4_7.sce new file mode 100755 index 000000000..e442e8c2c --- /dev/null +++ b/3035/CH4/EX4.7/Ex4_7.sce @@ -0,0 +1,15 @@ + +// Variable Declaration +r = 0.6 //Radius of each conductor(cm) +d = 150 //Separation distance(cm) +L = 40*10**3 //Length of overhead line(m) +f = 50 //Frequency(Hertz) +v = 50*10**3 //System voltage(V) + +// Calculation Section +C_ab = (%pi * 8.854 * 10**(-12))/(log(d/r)) * L //Capacitance b/w conductors(F) +I = complex(0,v * 2 * %pi * f * C_ab) //Charging current leads voltage by 90°(A) + +// Result Section +printf('Capacitance between two conductors , C_ab = %.3e F' ,C_ab) +printf('Charging current , I = j%.3f A' ,imag(I)) diff --git a/3035/CH4/EX4.8/Ex4_8.sce b/3035/CH4/EX4.8/Ex4_8.sce new file mode 100755 index 000000000..c434fed23 --- /dev/null +++ b/3035/CH4/EX4.8/Ex4_8.sce @@ -0,0 +1,28 @@ + +// Variable Declaration +r = 0.015 //Radius of each conductor(m) +D_a1a2 = 0.3 //Distance b/w conductor a1 & a2(m) +D_a2a1 = 0.3 //Distance b/w conductor a2 & a1(m) +D_a1b1 = 15.3 //Distance b/w conductor a1 & b1(m) +D_a1b2 = 15.6 //Distance b/w conductor a1 & b2(m) +D_a2b1 = 15.0 //Distance b/w conductor a2 & b1(m) +D_a2b2 = 15.3 //Distance b/w conductor a2 & b2(m) +D_b1c1 = 15.3 //Distance b/w conductor b1 & c1(m) +D_b1c2 = 15.6 //Distance b/w conductor b1 & c2(m) +D_b2c1 = 15.0 //Distance b/w conductor b2 & c1(m) +D_b2c2 = 15.3 //Distance b/w conductor b2 & c2(m) +D_a1c1 = 30.6 //Distance b/w conductor a1 & c1(m) +D_a1c2 = 30.9 //Distance b/w conductor a1 & c2(m) +D_a2c1 = 30.3 //Distance b/w conductor a2 & c1(m) +D_a2c2 = 30.6 //Distance b/w conductor a2 & c2(m) + +// Calculation Section +D_s = (D_a1a2 * r * D_a2a1 * r)**(1.0/4) //Geometric mean radius(m) +D_ab = (D_a1b1 * D_a1b2 * D_a2b1 * D_a2b2)**(1.0/4) //Mutual GMD b/w conductor a & b(m) +D_bc = (D_b1c1 * D_b1c2 * D_b2c1 * D_b2c2)**(1.0/4) //Mutual GMD b/w conductor b & c(m) +D_ca = (D_a1c1 * D_a1c2 * D_a2c1 * D_a2c2)**(1.0/4) //Mutual GMD b/w conductor c & a(m) +D_m = (D_ab * D_bc * D_ca)**(1.0/3) //Geometric mean separation(m) +C_n = 2 * %pi * 8.854 * 10**(-9) /(log(D_m/D_s)) //Capacitance per phase(F/km) + +// Result Section +printf('Capacitance per phase , C_n = %.3e F/km' ,C_n) diff --git a/3035/CH4/EX4.9/Ex4_9.sce b/3035/CH4/EX4.9/Ex4_9.sce new file mode 100755 index 000000000..368774e84 --- /dev/null +++ b/3035/CH4/EX4.9/Ex4_9.sce @@ -0,0 +1,14 @@ + +// Variable Declaration +r = 0.015 //Radius of each conductor(m) +D_ab = 15 //Horizontal distance b/w conductor a & b(m) +D_bc = 15 //Horizontal distance b/w conductor b & c(m) +D_ac = 30 //Horizontal distance b/w conductor a & c(m) + +// Calculation Section +D_m = (D_ab * D_bc * D_ac)**(1.0/3) //Geometric mean separation(m) +D_s = 2**(1.0/2) * r //Geometric mean radius(m) +C_n = 2 * %pi * 8.854 * 10**(-9) /(log(D_m/D_s)) //Capacitance/phase/km(F/km) + +// Result Section +printf('Capacitance per phase , C_n = %.3e F/km' ,C_n) |