Vous êtes sur la page 1sur 23

Aim 1

Design of squirrel cage induction motor

Software Used Matlab


Matlab Program
clc;
clear all;
close all;
Po = 30*.746; %kw
Vin = 440;
N = 960;
Ns = N/60;
f = 50;
Bav = .46;
pf = .87;
e = .86;
ac = 25000;
Kws = .955;
phase = 3;
%rating in kVA
Q = Po/(e*pf);
Kw = .9;
fprintf('\nProgram to design squirrel cage induction motor');
fprintf('\n');
Co = 1.11*pi*pi*Bav*ac*Kw*(10^-3);
%number of poles
pole = (2*f)/Ns;
%Q = Co*Ns*D2L
fprintf('\nInput power or rating power = ');
disp(Q);
D2L = Q/(Co*Ns);
%for good overall design
%L/tow = 1
%L*pole/pi*D
D3 = (Q*pole)/(Co*Ns*pi);
D = D3^(1/3);
fprintf('\nHence Diameter D = ');
disp(D);
fprintf('\nHence Length L = ');
L = pi*D/(pole);
disp(L);
%peripheral speed Va
Va = pi*D*Ns;
fprintf('\nPeripheral speed = ');
disp(Va);
if(Va<30)
fprintf('\nAs Peripheral speed is less than 30m/secs so dimensions are
permissable');
else

fprintf('\nAs Peripheral speed is not less than 30m/sec the dimensions are not
mpermissabel. But still the dimensionswill be');
end
phim = Bav*pi*D*L/pole;
fprintf('\nFlux density phim = ');
disp(phim);
%number of stator turns Ts
Ts = Vin/(4.44*f*phim*Kws);
fprintf('\nNumber of stator turns Ts = ');
disp(round(Ts));
%total number of stator slot per phase per pole Ss
Ss = 3*pole*phase;
fprintf('\nTotal number of stator slot per phase per pole Ss');
disp(Ss);
fprintf('\nSlot pitch Yss = ');
Yss = pi*D/Ss;
disp(Yss);
Zss = 6*round(Ts);
fprintf('\nTotal Coonductors Zss = ');
disp(Zss);
fprintf('\nNumber of Slots = ');
noofslots = Zss/Ss;
disp(noofslots);
fprintf('\n');

AIM 2
Design of salient pole Alternator machine
Software Used- Matlab

Matlab Program
clc;
clear all;
close all;
% given
pole = 2;
Eline = 11000;
Po = 75000;
ac = 50000;
Va = 180;
Kw = .95;
J = 6;
N = 3000;
f = 50;
Bav = .6;
% Now
Ns = N/60;
P = (2*f)/Ns;
fprintf('\nProgram to calculate D and L for a salient pole alternator');
fprintf('\n-');
fprintf('\nSo diameter D = ');
D = Va/(pi*Ns);
disp(D);
% output coe??ecient
Co = 1.11*pi*pi*Bav*ac*Kw;
L = (Po*10^3)/(Co*Ns*D*D);
fprintf('\nAnd Length L = ');
disp(L);
% Now ??ux phi
phi = pi*D*L*Bav;
phipole = phi/pole;
Eph = Eline/sqrt(3);
Tph = Eph/(4.44*f*Kw*phipole);
fprintf('\nTurns per phase = ');
disp(round(Tph));
Iph = (Po*10^3)/(3*Eph);
fprintf('\nCurrent per phase = ');
disp(Iph);
% total amp conductors
AT = pi*D*ac;
fprintf('\nTotal amp conductors = ');
disp(AT);
% conductors per slot
Zs = AT/Iph ;
fprintf('\nTotal conductors per slot = ');

disp(round(Zs));
% stator conductors
Ss = 6*round(Tph);
fprintf('\nTotal stator conductors per slot = ');
disp(Ss);
% Area of conductors
Ac = Iph/J;
fprintf('\nArea of conductors Ac = ');
disp(Ac);

Aim 3
Design of single phase shell type transformer
Software Used-Matlab

Matlab
clc;
clear all;
close all;
%Given
Q = 125;
Vin = 6610;
Vout = 400;
J = 2;
f = 50;
Bm = 1.1;
K = .9;
%also given core depth b = 2 width of central limb
Et = 10;
fprintf('\nProgram to design a single phase shell type transformer');
fprintf('\n-');
fprintf('\nArea of iron core = ');
Ai = Et/(4.44*f*Bm);
disp(Ai);
fprintf('\nGross iron area = ');
Agi = Ai/K;
disp(Agi);
%as Agi = b*2a
%and b = 2.5 2a = 5a
a = sqrt(Agi/5);
b = 5*a;
fprintf('\nCore depth b = ');
disp(b);
fprintf('\nWidth of central limb 2a = ');
disp(2*a);
fprintf('\nFor shell type');
fprintf('\nDepth of Yoke Dy = ');
Dy = a;
disp(Dy);
fprintf('\nHeight of Yoke Hy = ');
Hy = b;
disp(Hy);
%Q = 2.22fBmAiAwKw
Kw = .33;
Aw = Q/(2.22*f*Bm*Ai*Kw*J);
fprintf('\nArea of window Aw = ');
disp(Aw);
%given Hw = 3Ww
Ww = sqrt(Aw/3);
Hw = 3*Ww;
H = Hw + (2*a);
W = (2*Ww) + (4*a);

fprintf('\nOverall height of window H = ');


disp(H);
fprintf('\nOverall width of window W = ');
disp(W);
fprintf('\nArea of primary(mm2) = ');
Ip = (Q*1000)/Vin;
ap = Ip/J;
disp(ap);
fprintf('\nArea of secondary(mm2) = ');
Is = (Q*1000)/Vout;
as = Is/J;
disp(as);

Aim 4
Design of cylindrical pole synchronous machine
Software Used matlab
Matlab code
clc;
clear all;
close all;
%given
Bav = .55;
ac = 36000;
J = 5;
Va = 160;
Ns = 50;
pole = 2;
Q = 15000;
f = 50;
Eline = 11000;
%therfore D
D = Va/(pi*Ns);
%%Now distribution factor for 60 degree phase spread in
%order to eliminate 5th harmonic
%Kd = .955;
alpha = (2*acosd(0))/5;
%Why as cos(5*alpha/2) = 0 for 5th harmonic
fprintf('\nProgram to calculate D, L size and numer of conductors of Synch
machine');
fprintf('\n');
fprintf('\nFor 5th harmonic elimination we have alpha = ');
disp(alpha);
fprintf('\nUsing alpha we also get..');
% pitch factor Kp
Kp = cosd(alpha/2);
fprintf('\nPitch factor Kp = ');
disp(Kp);
% giving Kw
fprintf('\nStacking Factor Kw = ');
Kw = Kp*Kd;
disp(Kw);
% using Kw we get output coeffecient
Co = 1.11*pi*pi*f*Bav*ac*Kw*.001
fprintf('\nWe have Diameter D = ');
disp(D);
fprintf('\nLength L = ');
L = (Q)/(Co*Ns*D*D);
disp(L);
%Now flux phi
phi = pi*D*L*Bav;
fprintf('\nWe got Flux phi = ');

disp(phi);
phipole = phi/pole;
%Turn per phase
Eph = Eline/sqrt(3);
y = Eph/(4.44*f*Kw*phipole);
Tph = ceil (y)
fprintf('\nTurns per phase Tph = ');
disp(Tph);
%total conductors Z
x = 6*Tph;
z = ceil (x)
fprintf('\nTotal conductors Z = ');
disp(Z);
%copnductors per slot
Ss = Z/(2*pole);
fprintf('\nConductors per slot = ');
disp(Ss);

Aim 5
Single phase induction motor

Matlab code
clc;
clear;
close all;

%% Input Data
R1=3.5;
f=50;
Poles=4;
% No load Test Data

% Stator resistance
% Frequency
% No. of poles

%No load Currents


Ia_nl=2.5;
Ib_nl=2.5;
Ic_nl=2.5;
I1=(Ia_nl+Ib_nl+Ic_nl)/3;

%
%
%
%

Line current of phase A at no load


Line current of phase B at no load
Line current of phase C at no load
Average per phase current

%No load Applied Voltage


Vab_nl=230;
Vbc_nl=230;
Vca_nl=230;
VL_nl=(Vab_nl+Vbc_nl+Vca_nl)/3;

%
%
%
%

Line voltage
Line voltage
Line voltage
Average line

Pin_nl=106;

% No Load input Power

V_ab at
V_bc at
V_ca at
to line

no load
no load
no load
voltage

%Blocked Rotor test Data


Ia_fl=2.6;
Ib_fl=2.6;
Ic_fl=2.6;
I2=(Ia_fl+Ib_fl+Ic_fl)/3;
% Full load Applied Voltage
Vab_fl=64;
Vbc_fl=64;
Vca_fl=64;
VL_fl=(Vab_fl+Vbc_fl+Vca_fl)/3;
Pin_fl=169;

%
%
%
%
%
%
%
%

Line current of phase A at full load


Line current of phase B at full load
Line current of phase C at full load
Average per phase current
Line voltage
Line voltage
Line voltage
Average line

V_ab at
V_bc at
V_ca at
to line

full load
full load
full load
voltage

% Full Load input Power

%% Calculation using no-load test data

Vp=VL_nl/sqrt(3);
circuit
Znl=Vp/I1;
P_scl=3*I1*I1*R1;
P_rot=Pin_nl-P_scl;
PF_nl=Pin_nl/(sqrt(3)*VL_nl*I1);
angle_nl=acos(PF_nl)*180/pi;
angle_nl_r=acos(PF_nl);
Vm=Vp-I1*R1;
Im=I1*sin(angle_nl_r);
Ic=I1*PF_nl;
Rc=Vm/Ic;
Xm=Vm/Im;
Zm=(j*Xm*Rc)/(j*Xm+Rc);
Rnl=Znl*PF_nl;
factor
Xnl=Znl*sin(angle_nl_r);
factor
Znl_complex=Rnl+j*Xnl;
X1_a=Xnl-imag(Zm);
of Znl
X1=Znl-Xm;
i.e. Znl=X1+Xm

% Calculate phase voltage for per phase


%
%
%
%
%
%
%
%
%
%
%
%
%

No-load Impedance = X1+Xm


Stator copper losses
Rotational Losses
No load power factor
No load power factor angle in degrees
No load power factor angle in radians
Voltage across Magnitising branch
Current through Xm
Current through Rc
Value of core resistance
Value of magnetising reactance
Magnitising branch impedance
No load resistance from Znl and power

% No load reactance from Znl and power


% No load impedance in complex form
% Calculation of Xm using imaginary part
% Calculation of X1 using approximation

disp(['No load calculations for trasformer equivalent circuit'])


disp(['------------------------------------------------------'])
disp(['Sator Resistance
= R1
= ' num2str(R1) ' ohm'])
disp(['Line to line voltage
= Vl
= ' num2str(VL_nl) ' V']);
disp(['No load Current
= I1
= ' num2str(I1) ' A']);
disp(['No load Input Power Pin = Pin = ' num2str(Pin_nl) ' W'])
disp(['Phase Voltage at no load = Vp
= ' num2str(Vp) ' V']);
disp(['No load Impedance Znl
= Znl = ' num2str(Znl) ' ohms']);
disp(['No Load power factor
= PFnl = ' num2str(PF_nl)]);
disp(['Power factor angle
= phi = ' num2str(angle_nl) ' degree']);
disp(['Magnitizing branch volt = Vm
= ' num2str(Vm) ' V']);
disp(['Current through Xm
= Im
= ' num2str(Im) ' A']);
disp(['Current through Rc
= Ic
= ' num2str(Ic) ' A']);
disp(['Magnitizing Reactance
= Xm
= ' num2str(Xm) ' ohms']);
disp(['Core Resistance
= Rc
= ' num2str(Rc) ' ohms']);
disp(['Magnitizing Impedance
= Zm
= ' num2str(Zm) ' ohms']);
disp(['Approximate Reactance
= X1
= ' num2str(X1) ' ohms'])
disp(['Stator Copper Losses
= Pscl = ' num2str(P_scl) ' W']);
disp(['Rotational Losses
= Prot = ' num2str(P_rot) ' W']);
%% Calculation from blocked rotor test
Vfl=VL_fl/sqrt(3);
R2=(Pin_fl-3*I2*I2*R1)/(3*I2*I2);
Zfl=Vfl/I2;
PFfl=Pin_fl/(sqrt(3)*VL_fl*I2);
angle_fl=acos(PFfl)*180/pi;
Rfl=Zfl*PFfl;
Xfl=Zfl*sin(acos(PFfl));
Zfl_c=Rfl+Xfl*j;
X2=sqrt(Zfl*Zfl-(R1+R2)^2)-X1;

%
%
%
%
%
%
%
%
%

Full load phase voltage


Calculating R2 from copper losses
Full load equivalent impedence
Full load power factor
Full load Power factor Angle
Full load equivalent resistance
Full load equivalent raectance
Full load impedence in complex form
Calculation of X2

disp([' ']);
disp(['Full load calculations for trasformer equivalent circuit'])
disp(['--------------------------------------------------------'])
disp(['Full laod Line Voltage
= VLfl = ' num2str(VL_fl) ' V']);
disp(['Full load Phase Voltage = Vfl = ' num2str(Vfl) ' ohms'])
disp(['Full laod Current
= I2
= ' num2str(I2) ' A']);
disp(['Full laod Impedance
= Zfl = ' num2str(Zfl) ' ohms']);
disp(['Full load Power
= Pfl = ' num2str(Pin_fl) ' W'])
disp(['Full load Power factor
= PFfl = ' num2str(PFfl) ' '])
disp(['Power factor angle
= phi = ' num2str(angle_fl) ' degree']);
disp(['Full load Imedance
= Zfl = ' num2str(Zfl_c) ' ohm']);
disp(['Rotor resistance
= R2
= ' num2str(R2) ' ohms']);
disp(['Approximate X2
= X2
= ' num2str(X2) ' ohms'])
%% Calculation of thevenin equivalent circuit parameters
Vth=(Xm/(X1+Xm))*Vp;
Rth=(Xm/(X1+Xm))^2*R1;
Xth=X1;
Ns=120*f/Poles;
ws=Ns*2*pi/60;

%
%
%
%
%

calculating thevenin equivalent voltage


calculation of thevenin resistance
calculation of thevenin reactance
calculation of synchronous frequency
converting 'rpm' into 'rad/sec'

Tstart=(3*Vth^2*R2)/(ws*((Rth+R2)^2+(Xth+X2)^2));
torque of motor
Smax=R2/sqrt(Rth^2+(Xth+X2)^2);
torque
Tmax=(3*Vth^2)/(2*ws*(Rth+sqrt(Rth^2+(Xth+X2)^2)));
torque

% Caculating starting
% Slip for maximum
% Calulating maximum

disp([' ']);
disp(['Thevenin Calculation from Induction motor equivalent cicuit'])
disp(['-----------------------------------------------------------'])
disp(['Thevenin Voltage
= Vth = ' num2str(Vth) ' V'])
disp(['Thevenin Resistance
= Rth = ' num2str(Rth) ' ohms'])
disp(['Thevenin Reactance
= Xth = ' num2str(Xth) ' ohms'])
disp([' ']);
disp(['Calculation of starting and pull-out torque '])
disp(['-------------------------------------------'])
disp(['Rated frequency
= f
= ' num2str(f) ' Hz'])
disp(['No. of poles
= P
= ' num2str(Poles) ' '])
disp(['Synchronous speed
= Ns
= ' num2str(Ns) ' rpm'])
disp(['Synchronous speed
= Ws
= ' num2str(ws) ' rad/sec'])
disp(['Starting Torque, Tstart = Ts
= ' num2str(Tstart) ' N.m'])
disp(['Slip for Tmax
= Sm
= ' num2str(Smax) ' '])
disp(['Maximum Torque, Tmax
= Tm
= ' num2str(Tmax) ' N.m'])
%% Plotting torque speed characteristics
s=1:-0.001:0;
s(1001)=0.001;
Nm=(1-s)*Ns;
for ii=1:1000
Tind(ii)=(3*Vth^2*R2/s(ii))/(ws*((Rth+R2/s(ii))^2+(Xth+X2)^2));
end
Tind(1001)=Tind(1000);
plot(Nm,Tind);

axis([0,Ns,0,Tmax+1]);
xlabel('Rotor Speed (rpm)');
ylabel('Torque induced N.m');
title('Torque speed curve of induction motor');
Nmax=(1-Smax)*Ns;
x=[Nmax, Nmax];
y=[0,Tmax];
hold on;
line(x,y,'Color','r','LineStyle',':','LineWidth',1)
text(Nmax,Tmax+0.35,'Pull out Torque');
plot(Nmax,Tmax,'Marker','o')
text(Nmax+10,0.35,'Smax')
plot(Nmax,0,'Marker','o')
text(15,Tstart-0.25,'Starting Torque');
plot(0,Tstart,'Marker','o')

Aim 6

To design Commutator of the Electrical Machine using MATLAB.

clc;
clear all;
close all;
arm_dia = 800;
% Armature Diameter
N = 700;
Z = 672;
b_t = 10;
% Brush Thickness
b_w = 20;
% Brush Width
b_h = 32;
% Brush Height
J = 6;
% Current Density
b_fri_coe = 0.2;
% Brush Friction Coefficient
b_pre = 13000;
% Brush Pressure
Vd = 2;
% Voltage drop across Brush Set
P = 6;
% Poles
comm_dia = 0.66*arm_dia
% Commutator Diameter
Vc = pi*comm_dia*(N/60)
% Speed of Commutator
if (Vc>20)
end;
Nc = Z/2
% No. of Commutator Segments
pit_comm = pi*(comm_dia/Nc)
% Pitch of Commutator Segment
if (pit_comm>10)
end;
gap = pi*(comm_dia/P)
% Gap b\w Brush Spindles
if ((gap<250)&&(gap>300))
end;
nbps = (836.66*2)/(P*6*b_t*(b_w/100))% No. of Brushes per Spindles
comm_len = nbps*(b_w + 5) + 90
% Commutator Length
bfl = b_fri_coe*P*b_w*b_t*(10^-6)*nbps*b_pre*Vc % Brush Friction Loss
bcl = 836.33*Vd
% Brush Contact Loss
comm_loss = bfl + bcl
% Total Commutator Loss
Wt_comm = comm_len*pi*((comm_dia^2)/4)*8.9*(10^-6)% Wt. of Commutator Copper

Aim 7

To design Armature Winding of DC Machine using MATLAB

Matlab code
clc;
clear all;
close all;
D = 800;
q = 36500;
P = 6;
dVp = 3;
V = 600;
A = 6;
P = 6;
N = 700;
Fl = 0.0788;
SpP = 14;
IFL = 833.33;
Isf = 3;
J = 5;
wc = 1.9; % Conductor Width
ATpP = pi*D*q*(10^-3)/(2*P)
E = (1 + dVp/100)*V
Z = (E*60*A)/(P*Fl*N)
S = SpP*P
sp = pi*D/S
Zs = Z/S
Z = Zs*S
Fl = (E*60*A)/(P*Z*N)
CV = IFL*Zs/A
Ia = IFL + Isf
ac = Ia/(A*J)
hc = ac/wc

% No. of Parallel Path


% Poles
% Flux per pole
% Slots per Pole
% Shunt Field Current
% Current Density
% Armature AT per pole
% Total no. of Conductor
% Slot pitch
% Conductors per slot
% Corrected value of Conductors
% Corrected value of Flus per pole
% Current volume per slot
% Armature Current
% Conductor Area
% Conductor height

Aim 8

design Stator Core for Synchronous Machine using MATLAB

Matlab code

clc;
clear all;
close all;
J = 4;
% Current Density(A/mm^2)
Iph = 349.9;
% Phase Current(A)
As = Iph/J % Conductor Area(mm^2)
Tp = 7;
% No. of Teeth under Pole arc
Bto = 1.8;
Li = 522;
F = 0.0936;
% Flux
Wt = F/(Bto*Li*Tp) % Tooth width at air gap(mm)
Ps = 32.72;
% Slot Pitch(mm)
Ws = Ps-Bto% Slot Width(mm)
Wc = 13;
% Conductor Width(mm)
Tc = 7;
% Conductor Thickness(mm)
Hs = 45;
%Height of Slot(mm)
PP = 294.52;
KV = 3.3;
Lmt = 1340+(2.5*PP)+150+(50*3.3)
% Mean Length of Turn
Tph = 96;
As = Tc*Wc
Rph = 0.021*Lmt*Tph/As % Stator Wedge Resistance per phase
Ps = 3*Iph*Iph*Rph*(10^(-3))
% DC Copper Loss

Vous aimerez peut-être aussi