summaryrefslogtreecommitdiff
path: root/503/CH9
diff options
context:
space:
mode:
Diffstat (limited to '503/CH9')
-rwxr-xr-x503/CH9/EX9.1/ch9_1.sci20
-rwxr-xr-x503/CH9/EX9.10/ch9_10.sci9
-rwxr-xr-x503/CH9/EX9.11/ch9_11.sci19
-rwxr-xr-x503/CH9/EX9.12/ch9_12.sci26
-rwxr-xr-x503/CH9/EX9.13/ch9_13.sci21
-rwxr-xr-x503/CH9/EX9.14/ch9_14.sci24
-rwxr-xr-x503/CH9/EX9.15/ch9_15.sci49
-rwxr-xr-x503/CH9/EX9.17/ch9_17.sci19
-rwxr-xr-x503/CH9/EX9.18/ch9_18.sci13
-rwxr-xr-x503/CH9/EX9.19/ch9_19.sci14
-rwxr-xr-x503/CH9/EX9.2/ch9_2.sci33
-rwxr-xr-x503/CH9/EX9.3/ch9_3.sci29
-rwxr-xr-x503/CH9/EX9.4/ch9_4.sci40
-rwxr-xr-x503/CH9/EX9.5/ch9_5.sci51
-rwxr-xr-x503/CH9/EX9.6/ch9_6.sci45
-rwxr-xr-x503/CH9/EX9.9/ch9_9.sci60
16 files changed, 472 insertions, 0 deletions
diff --git a/503/CH9/EX9.1/ch9_1.sci b/503/CH9/EX9.1/ch9_1.sci
new file mode 100755
index 000000000..ea35e96b9
--- /dev/null
+++ b/503/CH9/EX9.1/ch9_1.sci
@@ -0,0 +1,20 @@
+// to campute cu loss in rotoe windings, input to the motor, efficiency
+
+clc;
+f_s=120/60; //cycles/min
+f=50;
+s=f_s/f;
+n_s=1000;
+n=(1-s)*n_s;
+w=n*2*%pi/60;
+T=160;
+P=T*w;
+T_L=10;
+P_m=(T+T_L)*w;
+cu=P_m*(s/(1-s)); disp(cu,'rotor cu loss(W)');
+
+P_sl=800; //stator loss
+P_in=P_m+cu+P_sl; disp(P_in,'power i/p to motor(W)');
+
+eff=P/P_in;
+disp(eff*100,'efficiency(%)'); \ No newline at end of file
diff --git a/503/CH9/EX9.10/ch9_10.sci b/503/CH9/EX9.10/ch9_10.sci
new file mode 100755
index 000000000..9e6ca1df0
--- /dev/null
+++ b/503/CH9/EX9.10/ch9_10.sci
@@ -0,0 +1,9 @@
+//to calculate max torque and slip, starting torque
+
+clc;
+k=5; //k=I_s/I_fl
+s_fl=0.04;
+s_max_T=sqrt((s_fl^2*(1-k^2))/((k*s_fl)^2-1));disp(s_max_T,'slip');
+T_max=.5*(s_max_T^2+s_fl^2)/(s_fl*s_max_T);disp(T_max,'max torque(pu)');
+
+T_s=k^2*s_fl;disp(T_s,'starting torque(pu)'); \ No newline at end of file
diff --git a/503/CH9/EX9.11/ch9_11.sci b/503/CH9/EX9.11/ch9_11.sci
new file mode 100755
index 000000000..59899d2bd
--- /dev/null
+++ b/503/CH9/EX9.11/ch9_11.sci
@@ -0,0 +1,19 @@
+//to find starting current and torque, necessary exteranl resistance and corresponding starting torque
+
+clc;
+f=50;
+R2=.1;
+X2=2*%pi*f*3.61*10^-3;
+a=3.6;
+R22=a^2*R2;
+X22=a^2*X2;
+V=3000;
+n_s=1000;
+w_s=2*%pi*n_s/60;
+I_s=(V/sqrt(3))/sqrt(R22^2+X22^2);disp(I_s,'starting current(A)');
+T_s=(3/w_s)*(V/sqrt(3))^2*R22/(R22^2+X22^2);disp(T_s,'torque(Nm)');
+
+Iss=30;
+Rext=sqrt(((V/sqrt(3)/Iss)^2-X22^2)-R22);
+disp(Rext,'external resistance(ohm)');
+T_s=(3/w_s)*(V/sqrt(3))^2*(R22+Rext)/((R22+Rext)^2+X22^2);disp(T_s,'torque(Nm)');
diff --git a/503/CH9/EX9.12/ch9_12.sci b/503/CH9/EX9.12/ch9_12.sci
new file mode 100755
index 000000000..92d922b75
--- /dev/null
+++ b/503/CH9/EX9.12/ch9_12.sci
@@ -0,0 +1,26 @@
+//find line current and starting torque with direct switching, stator resistance starting, autotransformer starting, star delta starting, autotransformer ratio give 1 pu
+
+clc;
+//I_s/I_fl=6;
+s_fl=0.05;
+disp('by direct switching');
+Is=6;disp(Is,'line current(pu)');
+T=Is^2*s_fl;disp(T,'torque(pu)');
+
+disp('by stator resistance starting');
+Is=2;disp(Is,'line current(pu)'); //given
+T=Is^2*s_fl;disp(T,'torque(pu)');
+
+disp('by autotransformer starting');
+x=2/6;
+Is_motor=2;
+Is=Is_motor*x;disp(Is,'line current(pu)');
+T=Is^2*s_fl;disp(T,'torque(pu)');
+
+disp('by star delta starting');
+Is=(1/3)*6;disp(Is,'line current(pu)');
+T=Is^2*s_fl*3;disp(T,'torque(pu)');
+
+disp('by autotransformer starting');
+Ts=1;
+x=sqrt(Ts/((6^2)*s_fl));disp(x,'x'); \ No newline at end of file
diff --git a/503/CH9/EX9.13/ch9_13.sci b/503/CH9/EX9.13/ch9_13.sci
new file mode 100755
index 000000000..b8ec49b47
--- /dev/null
+++ b/503/CH9/EX9.13/ch9_13.sci
@@ -0,0 +1,21 @@
+//to find resistance added to ckt
+
+clc;
+Rrot=.061;
+R2=Rrot/2;
+f=50;
+P=12;
+w_s=(120*f/P)*(2*%pi/60);
+s=0.045;
+w=(1-s)*w_s;
+P=200*10^3;
+T_fan=P/w;
+I2=sqrt(T_fan*w_s*s/(3*R2));
+E2=I2*R2/s;
+n=450;
+ww=2*%pi*n/60;
+nn=500;
+ss=(nn-n)/nn;
+Tnew=T_fan*(ww/w)^2;
+Rt=(3/w_s)*(E2*ss)^2/(ss*Tnew);
+Rext=Rt-R2;disp(Rext,'external resistance(ohm)'); \ No newline at end of file
diff --git a/503/CH9/EX9.14/ch9_14.sci b/503/CH9/EX9.14/ch9_14.sci
new file mode 100755
index 000000000..0e294ec0e
--- /dev/null
+++ b/503/CH9/EX9.14/ch9_14.sci
@@ -0,0 +1,24 @@
+//to find resistance added to ckt
+
+clc;
+n_s=1500;
+w_s=2*%pi*n_s/60;
+n=1250;
+s=1-n/n_s;
+//Im=(1/3)*(0.3+.25/s+j*1.83)ohm/ph
+T=150;
+V=440;
+//T=(3/w_s)*(V^2*(R_2t/s))/((.1+(R_2t/s))^2+(X1+X2)^2);
+//after solving R_2t^2-1.34*R_2t+0.093=0
+function [x]=quad(a,b,c)
+ d=sqrt(b^2-4*a*c);
+ x1=(-b+d)/(2*a);
+ x2=(-b-d)/(2*a);
+ if(x1>x2)
+ x=x1;
+ else
+ x=x2;
+ end
+endfunction
+[x]=quad(1,-1.34,0.093);
+Rext=x-0.083;disp(Rext,'external resitance(ohm)'); \ No newline at end of file
diff --git a/503/CH9/EX9.15/ch9_15.sci b/503/CH9/EX9.15/ch9_15.sci
new file mode 100755
index 000000000..923ffce41
--- /dev/null
+++ b/503/CH9/EX9.15/ch9_15.sci
@@ -0,0 +1,49 @@
+//to calculate the min resistance to be added and speed of the motor
+
+clc;
+V=400;
+a=2.5;
+X2=.4;
+R2=0.08;
+n_s=750;
+w_s=2*%pi*n_s/60;
+T=250;
+//T=(3/w_s)*((V/sqrt(3))/a)*R2t/(R2t^2+X2^2);
+//after solving
+//R2t^2-1.304*R2t+0.16=0
+function [x1,x2]=quad(a,b,c)
+ d=sqrt(b^2-4*a*c);
+ x1=(-b+d)/(2*a);
+ x2=(-b-d)/(2*a);
+endfunction
+[x1 x2]=quad(1,-1.304,0.16);
+ if(x1>x2)
+ R2t=x2;
+ else
+ R2t=x1
+ end
+Rext=R2t-R2;
+disp(Rext,'external resistance(ohm)');
+
+//T=(3/w_s)*((V/sqrt(3))/a)*(R2t/s)/((R2t/s)^2+X2^2);
+//after solving
+//(R2t/s)^2-1.304*(R2t/s)+0.16=0
+[x1 x2]=quad(1,-1.304,0.16);
+s=x2/x1;
+n=n_s*(1-s);
+disp(n,'speed(rpm)');
+
+//T=(3/w_s)*((V/sqrt(3))/a)*(R2/s)/((R2/s)^2+X2^2);
+//after solving
+//(R2/s)^2-1.304*(R2/s)+0.16=0
+[x1 x2]=quad(1,-1.304,0.16);
+R2=0.08;
+s1=R2/x1;
+s2=R2/x2;
+if(s1>s2)
+ ss=s2;
+ else
+ ss=s1
+ end
+n=n_s*(1-ss);
+disp(n,'speed(rpm)');
diff --git a/503/CH9/EX9.17/ch9_17.sci b/503/CH9/EX9.17/ch9_17.sci
new file mode 100755
index 000000000..dfce58daf
--- /dev/null
+++ b/503/CH9/EX9.17/ch9_17.sci
@@ -0,0 +1,19 @@
+//to find the ratio of currents and torques at the starting,V2/V1
+
+clc;
+f1=50;
+f2=60;
+f=f2/f1;
+V=1; //V=V2/V1
+s_max_T=0.2;
+//Is=I_s2/I_s1
+Is=V*sqrt((s_max_T^2+1)/(s_max_T^2+f^2));
+disp(Is,'ratio of currents at starting');
+//Ts=T_s2/T_s1
+Ts=V^2*((s_max_T^2+1)/(s_max_T^2+f^2));
+disp(Ts,'ratio of torques at starting');
+//Tmax=Tmax2/Tmax1
+Tmax=V^2/f^2;
+disp(Tmax,'ratio of max torques');
+Vr=sqrt(1/sqrt((s_max_T^2+1)/(s_max_T^2+f^2)));
+disp(Vr,'V2/V1'); \ No newline at end of file
diff --git a/503/CH9/EX9.18/ch9_18.sci b/503/CH9/EX9.18/ch9_18.sci
new file mode 100755
index 000000000..bf3b13ef7
--- /dev/null
+++ b/503/CH9/EX9.18/ch9_18.sci
@@ -0,0 +1,13 @@
+//to calculate ratio of torques at starting and at slip=0.05
+
+clc;
+R1=0.01;
+X1=.5;
+R2=0.05;
+X2=.1;
+Ts=((R1^2+X1^2)/(R2^2+X2^2))*(R2/R1);
+disp(Ts,'Tso/Tsi');
+
+s=0.05;
+T=(((R1/s)^2+X1^2)/((R2/s)^2+X2^2))*(R2/R1);
+disp(T,'To/Ti');
diff --git a/503/CH9/EX9.19/ch9_19.sci b/503/CH9/EX9.19/ch9_19.sci
new file mode 100755
index 000000000..14b1a1337
--- /dev/null
+++ b/503/CH9/EX9.19/ch9_19.sci
@@ -0,0 +1,14 @@
+//to compute acc time and value of rotor resistance
+
+clc;
+s=1-.96; //load is brought to .96 of n_s
+s_max_T=sqrt((1-s^2)/(2*log(1/s)));
+R=1.5;
+R2_opt=R*s_max_T;disp(R2_opt,'rotor resistance(ohm)');
+n=1000;
+w_s=2*%pi*n/60;
+V=415;
+Tmax=(3/w_s)*(.5*(V/sqrt(3))^2)/R;
+J=11;
+t_A=(J*w_s/(2*Tmax))*((1-s^2)/(2*s_max_T)+s_max_T*log(1/s));
+disp(t_A,'acc time(min)');
diff --git a/503/CH9/EX9.2/ch9_2.sci b/503/CH9/EX9.2/ch9_2.sci
new file mode 100755
index 000000000..956c0e816
--- /dev/null
+++ b/503/CH9/EX9.2/ch9_2.sci
@@ -0,0 +1,33 @@
+//to calculate torque,resitance to be added to rotor ckt
+
+clc;
+f=50;
+P=6;
+n_s=120*f/P;
+w_s=2*%pi*n_s/60;
+n=875;
+s_maxT=(n_s-n)/n_s;
+R_2=.25;
+X_2=R_2/s_maxT;
+T_max=10;
+//v=V/a
+v=sqrt((T_max*w_s*X_2)/(3*.5));
+T=((3)*v^2*(R_2/s))/(w_s*((R_2/s)^2+(X_2)^2));
+disp(T,'torque(Nm)');
+
+//from eqn(T_start/T_max)=(R2+Rext)*(X2/.5)/((R2+Rext)^2+X2^2)
+//after solving
+//Rt^2-6.67*Rt+4=0
+function [x]=quad(a,b,c)
+ d=sqrt(b^2-4*a*c);
+ x1=(-b+d)/(2*a);
+ x2=(-b-d)/(2*a);
+ if(x1>x2)
+ x=x2;
+ else
+ x=x1;
+ end
+endfunction
+Rt=quad(1,-6.67,4);
+r2=.25;
+disp(Rt-r2,'external resistance(ohm)');
diff --git a/503/CH9/EX9.3/ch9_3.sci b/503/CH9/EX9.3/ch9_3.sci
new file mode 100755
index 000000000..28b75f95b
--- /dev/null
+++ b/503/CH9/EX9.3/ch9_3.sci
@@ -0,0 +1,29 @@
+//to find slip at max torque,full load slip and rotor current at starting
+
+clc;
+//Tfl=(3/w_s)*(V^2*Rs/s_fl)/((R2/s_fl)^2+X2^2); (i)
+//Ts=(3/w_s)*(V^2*R2)/(R2^2+X2^2); (ii)
+//Tmax=(3/w_s)*(.5*V^2)/X2^2; (iii)
+//Tmax/Ts=2; k=R2/X2; (iii)/(ii)and solving
+//k^2-4*k+1=0;
+function [x]=quad(a,b,c)
+ d=sqrt(b^2-4*a*c);
+ x1=(-b+d)/(2*a);
+ x2=(-b-d)/(2*a);
+ if(x1>x2)
+ x=x2;
+ else
+ x=x1;
+ end
+endfunction
+k=quad(1,-4,1);
+disp(k,'s_max_T');
+
+//(iii)/(i)and solving
+//s_fl^2-1.072*s_fl+.072=0
+s_fl=quad(1,-1.072,.072);
+disp(s_fl,'s_fl');
+
+//a=I2_start/I2_fullload
+a=sqrt((k/s_fl)^2+1)/(k^2+1);
+disp(a,'I2_start/I2_fullload'); \ No newline at end of file
diff --git a/503/CH9/EX9.4/ch9_4.sci b/503/CH9/EX9.4/ch9_4.sci
new file mode 100755
index 000000000..a7d1361d6
--- /dev/null
+++ b/503/CH9/EX9.4/ch9_4.sci
@@ -0,0 +1,40 @@
+//to calculate stator current,pf, net mech o/p, torque, motor performance
+
+clc;
+j=sqrt(-1);
+Vt=400;
+P=6;
+f=50;
+Inl=7.5;
+Pnl=700;
+disp('block rotor test results');
+Vbr=150;
+Ibr=35;
+Pinbr=4000;
+R1=.55;disp(R1,'R1(ohm)');
+k=1/.5;
+s=0.04;
+Zbr=Vbr/(sqrt(3)*Ibr);
+Rbr=Pinbr/(3*Ibr^2);
+Xbr=sqrt(Zbr^2-Rbr^2);
+X1=Xbr/(1+.5);disp(X1,'X1(ohm)');
+X2=Xbr-X1;disp(X2,'X2(ohm)');
+disp('no load test results');
+Zo=Vt/(sqrt(3)*Inl);
+Ro=Pnl/(3*Inl^2);
+Xo=sqrt(Zo^2-Ro^2);
+Xm=Xo-X1;disp(Xm,'Xm(ohm)');
+R2=(Rbr-R1)*((Xm+X2)/Xm)^2;disp(R2,'R2(ohm)');
+Zf=1/((1/(j*Xm))+(1/((R2/s)+j*X2)));
+Rf=real(Zf);
+Xf=imag(Zf);
+Zin=R1+j*X1+Zf;
+I1=Vt/(sqrt(3)*Zin);
+Pin=sqrt(3)*Vt*abs(I1)*cosd(atand(imag(I1)/real(I1)));disp(Pin,'Pin(W)');
+Pg=3*abs(I1)^2*Rf;disp(Pg,'Pg(W)');
+Pm=(1-s)*Pg;disp(Pm,'Pm(W)');
+Prot=Pnl-3*Inl^2*R1;disp(Prot,'Prot(W)');
+Pout=Pm-Prot;disp(Pout,'Pout(W)');
+w_s=1000*2*%pi/60;
+Tnet=Pout/((1-s)*w_s);disp(Tnet,'Tnet(Nm)');
+eff=Pout*100/Pin;disp(eff,'eff(%)');
diff --git a/503/CH9/EX9.5/ch9_5.sci b/503/CH9/EX9.5/ch9_5.sci
new file mode 100755
index 000000000..00bd747dc
--- /dev/null
+++ b/503/CH9/EX9.5/ch9_5.sci
@@ -0,0 +1,51 @@
+//to determine ckt model parameters,parameters of thevenin equivalent, max torque and slip, stator current, pf and eff
+
+clc;
+j=sqrt(-1);
+//NL test
+V=3300;
+f=50;
+Inl=5;
+Po=2500;
+Zo=V/(sqrt(3)*Inl);
+Ro=Po/(3*Inl^2);disp(Ro,'Ro(ohm)');
+Xo=sqrt(Zo^2-Ro^2);disp(Xo,'Xo(ohm)');
+//BR test
+V_BR=400;
+I_BR=27;
+ff=15;
+P_BR=15000;
+Z_BR=V_BR/(sqrt(3)*I_BR);
+R_BR=P_BR/(3*I_BR^2);
+X_BR=sqrt(Z_BR^2-R_BR^2);
+x1=X_BR/2; //at 15 Hz
+X1=x1*f/ff; //at 50Hz
+disp(X1,'X1(ohm)');
+Xm=Xo-X1;disp(Xm,'Xm(ohm)');
+R1=3.75;
+R2=(R_BR-R1)*((Xm+X1)/Xm)^2;disp(R2,'R2(ohm)');
+
+V_TH=(V/sqrt(3))*complex(cosd(0),sind(0))*complex(0,Xm)/complex(R1,X1+Xm);
+disp(V_TH,'V_TH(V)');
+Z_TH=complex(0,Xm)*complex(R1,X1)/complex(R1,X1+Xm);
+disp(real(Z_TH),'R_TH(ohm)');
+disp(imag(Z_TH),'X_TH(ohm)');
+
+a=(sqrt(real(Z_TH)^2+(X1+imag(Z_TH))^2));
+s_max_T=R2/a;
+n_s=1000;
+Z_tot=complex(real(Z_TH)+a,X1+imag(Z_TH));
+I2=abs(V_TH)/abs(Z_tot);
+T_max=3*(I2^2)*R2/(s_max_T*(2*%pi*n_s/60));disp(T_max,'T_max(Nm)');
+
+Z_f=complex(0,Xm)*complex(81.25,X1)/complex(81.25,X1+Xm);
+Z_in=Z_f+complex(R1,X1);
+I1=V/(sqrt(3)*abs(Z_in));
+pf=cosd(atand(imag(Z_in)/real(Z_in)));
+s=.04;
+Pmechg=(1-s)*3*I1^2*real(Z_f);
+Prot=Po-Inl^2*R1;
+Pip=sqrt(3)*V*I1*pf;
+Pop=Pmechg-Prot;
+eff=Pop/Pip;disp(eff,'efficiency');
+Tint=Pmechg/((1-s)*2*%pi*n_s/60);disp(Tint,'internal torque developed(Nm)'); \ No newline at end of file
diff --git a/503/CH9/EX9.6/ch9_6.sci b/503/CH9/EX9.6/ch9_6.sci
new file mode 100755
index 000000000..5c2f425b8
--- /dev/null
+++ b/503/CH9/EX9.6/ch9_6.sci
@@ -0,0 +1,45 @@
+//to calculate starting torque and current,full load current,pf, torque , internal and overall eff,slip and max torque
+
+clc;
+R1=.3;
+R2=.25;
+X1=.6;
+X2=.6;
+Xm=35;
+Prot=1500;
+V=231;
+Z_TH=complex(0,Xm)*complex(R1,X1)/complex(R1,X1+Xm);
+V_TH=(V*complex(0,Xm))/complex(R1,X1+Xm);
+n_s=1500;
+w_s=2*%pi*n_s/60;
+
+s=1;
+Z_f=complex(0,Xm)*complex(R2,X2)/complex(R2,X2+Xm);
+R_f=real(Z_f);
+Z_in=Z_f+complex(R1,X1);
+I1=V/abs(Z_in);disp(I1,'starting current(A)');
+Tstart=3*I1^2*R_f/w_s;disp(Tstart,'starting torque(Nm)');
+
+n=1450;
+s=1-n/n_s;
+a=R2/s;
+Z_f=complex(0,Xm)*complex(a,X2)/complex(a,X2+Xm);
+R_f=real(Z_f);
+Z_in=Z_f+complex(R1,X1);
+I1=V/abs(Z_in);disp(I1,'full load current(A)');
+pf=cosd(atand(imag(Z_in)/real(Z_in)));disp(pf,'pf');
+P_G=3*I1^2*R_f;
+Popg=P_G*(1-s);
+Pop=Popg-Prot;
+Tnet=Pop/((1-s)*w_s);disp(Tnet,'net torque(Nm)');
+Vt=400;
+Pip=sqrt(3)*Vt*I1*pf;
+eff=Pop/Pip;disp(eff*100,'efficiency(%)');
+int_eff=Popg/Pip;disp(int_eff*100,'internal eff(%)');
+
+s_max_T=1/(sqrt(real(Z_TH)^2+(imag(Z_TH)+X1)^2)/R2);disp(s_max_T,'max slip');
+Z_tot=Z_TH+complex(R2/s_max_T,X2);
+I2=abs(V_TH)/abs(Z_tot);
+T_max=3*I2^2*(R2/s_max_T)/w_s;
+disp(T_max,'max torque(Nm)');
+
diff --git a/503/CH9/EX9.9/ch9_9.sci b/503/CH9/EX9.9/ch9_9.sci
new file mode 100755
index 000000000..2351e722e
--- /dev/null
+++ b/503/CH9/EX9.9/ch9_9.sci
@@ -0,0 +1,60 @@
+//to determine the line current,pf, power ip, shaft torque, mech op and efficiency
+
+clc;
+R1=1.4;
+R2=.6;
+X1=2;
+X2=1;
+Xm=50;
+V=400;
+Prot=275;
+n_s=1000;
+w_s=2*%pi*n_s/60;
+
+disp('slip=0.03');
+s=0.03;
+I2=(V/sqrt(3))/complex(R1+R2/s,X1+X2);
+Im=(V/sqrt(3))/(Xm*complex(cosd(90),sind(90)));
+I1=Im+I2;
+I_L=abs(I1);disp(I_L,'line current(A)');
+pf=cosd(atand(imag(I1)/real(I1)));disp(pf,'pf');
+Pip=sqrt(3)*V*abs(I1)*cosd(atand(imag(I1)/real(I1)));disp(Pip,'power i/p(W)');
+
+P_G=3*abs(I2)^2*R2/s;
+Pmechg=(1-s)*P_G;disp(Pmechg,'mech power op(W)');
+Popnet=Pmechg-Prot;
+Tnet=Popnet/(w_s*(1-s));disp(Tnet,'shaft torque(Nm)');
+eff=Popnet/Pip;disp(eff,'efficiency');
+
+disp('slip= -0.03');
+s=-0.03;
+I2=(V/sqrt(3))/complex(R1+R2/s,X1+X2);
+Im=(V/sqrt(3))/(Xm*complex(cosd(90),sind(90)));
+I1=-(Im+I2);
+I_L=abs(I1);disp(I_L,'line current(A)');
+pf=cosd(atand(imag(I1)/real(I1)));disp(pf,'pf');
+Pip=sqrt(3)*V*abs(I1)*cosd(atand(imag(I1)/real(I1)));disp(Pip,'power i/p(W)');
+
+P_G=3*abs(I2)^2*R2/s;
+Pmechop=(1-s)*P_G;
+Pmechipnet=-Pmechop;
+Pmechipg=Pmechipnet+Prot;disp(Pmechipg,'mech power op(W)');
+Tnet=Pmechipg/(w_s*(1-s));disp(Tnet,'shaft torque(Nm)');
+eff=Pip/Pmechipg;disp(eff,'efficiency');
+
+disp('slip= 1.2');
+s=1.2;
+I2=(V/sqrt(3))/complex(R1+R2/s,X1+X2);
+Im=(V/sqrt(3))/(Xm*complex(cosd(90),sind(90)));
+I1=Im+I2;
+I_L=abs(I1);disp(I_L,'line current(A)');
+pf=cosd(atand(imag(I1)/real(I1)));disp(pf,'pf');
+Pip=sqrt(3)*V*abs(I1)*pf;disp(Pip,'power i/p(W)');
+
+P_G=3*abs(I2)^2*.5/s;
+Pmechg=(1-s)*P_G;disp(Pmechg,'mech power op(W)');
+Pmechabs=-Pmechg;
+n=n_s*(1-s);
+w=2*%pi*n/60;
+Tnet=Pmechg/w;disp(Tnet,'torque developed(Nm)');
+P=Pmechabs+Pip;disp(P,'power disipated(W)'); \ No newline at end of file