Control System lab Experiments using Compose (VTU University Syllabus)

Size: px
Start display at page:

Download "Control System lab Experiments using Compose (VTU University Syllabus)"

Transcription

1 Control System lab Experiments using Compose (VTU University Syllabus) Author: Sijo George Reviewer: Sreeram Mohan Altair Engineering, Bangalore Version: 1 Date: 09/11/2016 1

2 CONTENTS EXP. 1: STEP RESPONSE OF A SECOND ORDER SYSTEM... 3 EXP.1.B STEP RESPONSE OF A SECOND ORDER SYSTEM FOR VARIOUS VALUES OF ZETA EXP.2 EFFECT OF P, PD, PI AND PID CONTROLLER EXP.3 ROOT LOCUS, BODE AND NYQUIST PLOT EXP.4 RELATION BETWEEN FREQUENCY RESPONSE AND TRANSIENT RESPONSE TABLE OF FIGURES FIGURE 1.a: STEP RESPONSE AND ADDITION OF ZERO TO THE GIVEN SYSTEM FIGURE 1.b: STEP RESPONSE FOR DIFFERENT DAMPING RATIO OF A SECOND ORDER SYSTEM FIGURE 2.a: EFFECT P, PD, PI AND PID CONTROLLERS FIGURE 3.a: ROOT LOCUS AND EFFECT OF ADDING POLES AND ZEROS 165 FIGURE 3.b: BODE PLOT OF THE GIVEN SYSTEM FIGURE 3.c: NYQUIST PLOT OF THE GIVEN SYSTEM...28 FIGURE 4.a: BODE PLOT FOR TRANSIENT AND FREQUENCY RESPONSE...31 FIGURE 4.b: RESONANT PEAK, MAX.OVERSHOOT AND DAMPING RATIO FIGURE 4.c: BANDWIDTH AND DAMPING RATIO

3 EXP. 1: STEP RESPONSE OF A SECOND ORDER SYSTEM Aim & Description: (1)To determine the step response of a second order system and evaluation of time domain specifications. (2) To evaluate the effect of additional zeros on time response of second order system. Step response is the time behavior of the outputs of a general system when its inputs change from zero to one in a very short time. G ( s) 3 s 1 10s 20 Software code: clc; clear; close all; sys.num = [1]; sys.den = [ ]; sys1=tf(sys); kp=dcgain(sys) ess=1/(1+kp) w = sqrt (sys.den(3)) zeta = sys.den(2) / (2*w) TD=(1+0.7*zeta)/w TS = 4/ (zeta*w) % Numerator % Denominator % Finding transfer function % gain when frequency is zero(s=0) % Steady state error % Finding natural frequency % Damping ratio % Delay time % Settling time TP = pi/ (w*sqrt(1-zeta^2)) % Peak Time TR=(pi-atan((sqrt(1-zeta^2))/zeta))/(w*sqrt(1-zeta^2)) Percentovershoot= exp(-zeta*pi/ sqrt(1-zeta^2))*100 % Rise Time % Overshoot subplot(2,2,1) [z,t]=step(sys); % Step response plot(t,z); title('step response'); xlabel('time (sec)'); 3

4 ylabel('amplitude');grid on; subplot(2,2,2) pzmap(sys.num,sys.den); % Pole zero plot title('pole zero map of the given system') grid on; %% Adding Zero to the given system sys.num = conv(sys.num,[1 1]); sys2=tf(sys) [f,t]=step(sys); subplot(2,2,3) plot(t,f); title('step response after addition of zero') xlabel('time (sec)'); ylabel('amplitude');grid on; subplot(2,2,4) pzmap(sys.num,sys.den) % Pole zero plot when zero is added title('pole zero map when zero is added') grid on; % Function created to display transfer function using string concept function [sys]=tf(varargin) if length(varargin)==1 sys=varargin{1}; b=sys.num; a=sys.den; if length(varargin)==2 b=varargin{1}; a=varargin{2}; 4

5 [fopen_fileid] = fopen('testfile.txt', 'w'); %open a text file l=length(b); m=length(a); % Number of numerator coefficients % Number of denominator coefficients %%%% Numerator if length(b)==1 % Check the numerator has only one coefficient fprintf(fopen_fileid, ' %g\n',b(1)); % Print numerator fprintf(fopen_fileid,' %s',' '); % to draw the separation b/w numerator and denominator if length(b)==2 % Check the numerator has two coefficients c{1}=sprintf('%g%s',b(1),'s'); % store first numerator coefficient in a cell 'c{1}' c{2}=b(); % store second numerator coefficient in a cell 'c{2}' fprintf(fopen_fileid, '%s',c{1}); % print numerator if b()>0 fprintf(fopen_fileid, '%s','+'); % to print + sign before the last coefficient if it is positive fprintf(fopen_fileid, '%g\n',c{}); fprintf(fopen_fileid,' %s',' '); % to draw the separation b/w numerator and denominator if length(b)>2 i=l-1; for k=1:l-2 coefficient % Check the numerator has more than two coefficients % Initializing value of i to print the exponential term % Loop defined for the numerator coefficients excluding the last and second last h=sprintf('%g%s%g',b(k),'s^',i); % Print numerator coefficient and storing to the variable 'h' c{k}=h; i=i-1; %store the numerator coefficient in a cell 'c' % Decrementing the power of i for printing the exponential terms in the correct way c{k+1}=sprintf('%g%s',b(k+1),'s'); % store the second last coefficient in 'c' c{k+2}=b(); % store last coefficient in 'c' c; 5

6 for t=1:length(c)-1 fprintf(fopen_fileid, '%s',c{t}); transfer function % Print the numerator coefficients except the last coefficient of the R=cell2mat(c(t+1)); T=strcmp(R(1),'-'); %returns 1 if the comparison matches if (t~=(length(c)-1)) if T==0 fprintf(fopen_fileid, '%s','+'); %to print + sign if the next coefficient is positive except the last digit if b()>0 fprintf(fopen_fileid, '%s','+'); %To print + sign before it when the last coefficient is positive fprintf(fopen_fileid,'%g\n',c{}); % Print the last numerator coefficient of the transfer function fprintf(fopen_fileid,' %s',' '); % Denominator if length(a)==1 % Check if the denominator has only one coefficient fprintf(fopen_fileid, '\n %g\n',a(1)); if length(a)==2 f{1}=sprintf('\n % Check if the denominator has two coefficients %g%s',a(1),'s'); f{2}=a(); fprintf(fopen_fileid, '%s',f{1}); % print denominator if a()>0 fprintf(fopen_fileid, '%s','+'); %to print + sign before the last coefficient it is positive fprintf(fopen_fileid, '%g\n',f{}); %print the last coefficient 6

7 if length(a)>2 %Check if the length of denominator has more than 2 coefficients j=m-1; for g=1:m-2 e=sprintf('%g%s%g',a(g),'s^',j); % storing s terms and its coefficient power in a variable f{g}=e; %assigning to a cell j=j-1; f{g+1}=sprintf('%g%s',a(g+1),'s'); f{g+2}=a(); fprintf(fopen_fileid, '\n term %s',f{1}); %to print the first coefficient of denominator along with the s R2=cell2mat(f(2)); T2=strcmp(R2(1),'-'); %returns 1 if the comparison matches if T2==0 fprintf(fopen_fileid, '%s','+'); %To print + sign before second term if it is a positive for u=2:length(f)-1 fprintf(fopen_fileid, '%s',f{u}); % to print the coefficients from second to last R1=cell2mat(f(u+1)); %converting cell to matrix T1=strcmp(R1(1),'-'); % gives 1 as output if the comparison matches if (u~=(length(f)-1)) if T1==0 fprintf(fopen_fileid, '%s','+'); %to print the + sign if the next coefficient is positive if a()>0 fprintf(fopen_fileid, '%s','+'); %to print + sign if the last coefficient is positive 7

8 fprintf(fopen_fileid, '%g\n',f{}); %to print the last coefficient fclose(fopen_fileid); content = type('testfile.txt'); sys=content{1,1} ; % Function for finding step response function [z,t]= step(varargin) if length(varargin)==1 % Check whether the input variable is of length 1 sys=varargin{1}; % store the incoming structure to variable sys num=sys.num; den=sys.den; t=0:0.1:25; % store numerator coefficients in variable num % store denominator coefficients in variable den % Plotting time length if length(varargin)==2 % Check whether the input variable is of length 1 num=varargin{1}; % store the numerator to variable num den=varargin{2}; % store the numerator to variable num t=0:0.1:25; % Plotting time length if length(varargin)==3 num=varargin{1}; den=varargin{2}; t=varargin{3}; % User defined time length [A,B,C,D]=tf2ss(sys.num,sys.den); % Finding State space matrices f=length(a); U=1; %Size of the A matrix % Step input 8

9 K=[1]; % Weighting factor for i=1:length(t) h{i}=c*(a^-1)*(e^(a*t(i))-eye(f))*b*k +D*K*U; % finding step response values z=cell2mat(h); % Conversion of cell to matrix % Function for finding pole zero map function pzmap(varargin) if length(varargin)==1 sys=varargin{1}; % assigning structure to variable sys num=sys.num; %Numerator den=sys.den; % Denominator if length(varargin)==2 num=varargin{1}; den=varargin{2}; % Numerator % Denominator z=roots(num); p=roots(den); % Finding zeros % Finding poles %%%.For Plotting poles for i=1:length(p) R=isreal(p(i)); % Check whether the poles are real or not switch (R) case 1 % case when Poles are real p1=[p(i),0]; p2=[p(i),0]; % Defining first point for plotting poles % Defining second point for plotting poles theta = atan2( p2(2) - p1(2), p2(1) - p1(1)); % Finding slope r = sqrt( (p2(1) - p1(1))^2 + (p2(2) - p1(2))^2); % Finding the length between the first and second point line = 0:0.01: r; 9

10 x = p1(1) + line*cos(theta); % set of x coordinates to plot y = p1(2) + line*sin(theta); % set of y coordinates to plot plot(x,y,'x'); % Plotting poles hold on; case 0 % Case when poles are imaginary. p1=[real(p(i)),imag(p(i))]; p2=[real(p(i)),imag(p(i))]; % Since both points(p1 &p2) are equal, it plots only the specified point theta = atan2( p2(2) - p1(2), p2(1) - p1(1)); r = sqrt( (p2(1) - p1(1))^2 + (p2(2) - p1(2))^2); line = 0:0.01: r; x = p1(1) + line*cos(theta); y = p1(2) + line*sin(theta); plot(x,y,'x'); hold on; %%%% Zeros for i=1:length(z) S=isreal(z(i)) % Check whether the zeros are real or not switch (S) case 1 % case when Poles are real q1=[z(i),0]; q2=[z(i),0]; theta = atan2( q2(2) - q1(2), q2(1) - q1(1)); r = sqrt( (q2(1) - q1(1))^2 + (q2(2) - q1(2))^2); line = 0:0.01: r; a = q1(1) + line*cos(theta); b = q1(2) + line*sin(theta); plot(a,b,'o'); 10

11 hold on; case 0 % Case when zeros are imaginary. q1=[real(z(i)),imag(z(i))]; q2=[real(z(i)),imag(z(i))]; theta = atan2( q2(2) - q1(2), q2(1) - q1(1)); r = sqrt( (q2(1) - q1(1))^2 + (q2(2) - q1(2))^2); line = 0:0.01: r; a = q1(1) + line*cos(theta); b = q1(2) + line*sin(theta); plot(a,b,'o'); % plotting zeros hold on; % Function for finding DC gain function kp=dcgain(varargin) if length(varargin)==1 % Check whether the incoming variable has length 1 sys=varargin{1}; num=sys.num; den=sys.den; % Assigning the incoming structure to sys % Numerator % Denominator if length(varargin)==2 % Check whether the incoming variable has length 1 num=varargin{1}; den=varargin{2}; % Numerator % Denominator kp=num()/den(); % DC gain 11

12 %Function for finding state space matrices in controllable canonical form from transfer function function[a,b,c,d]=tf2ss(b,a) d=length(a); %Length of denominator if a(1)~=1 %to make first coefficient of denominator equal to 1 a=a/a(1); m=d-1; %%%%%%%%----A MATRIX for j=1:m A(m,j)=-a(d); d=d-1; for k=m:-1:2 A(k-1,k)=1; B(m,1)=1; %B MATRIX %%%%%%%-----C MATRIX g=abs(length(a)-length(b)); if length(a)>length(b) for i=length(b):-1:1 b(i+g)=b(i); for l=1:g b(l)=0; if length(b)>length(a) for i=length(a):-1:1 a(i+g)=a(i); 12

13 for l=1:g a(l)=0; b f=m; for p=2:1:m+1 C(1,f)=b(p)-a(p)*b(1); f=f-1; D=b(1); %D MATRIX Simulation Results: sys1 = s^2+10s+20 sys2 = 1s s^2+10s+20 kp = 0.05 ( DC gain) ess = ( Steady state error) w = (Natural frequency) zeta = (Damping ratio) TD = (Delay time) TS = 0.8 (Settling Time) TP = i (Peak Time) TR = i (Rise Time) Percent overshoot = i (Percent Overshoot) 13

14 Figure 1.a: Step Response and addition of zero to the given system 14

15 EXP.1.B STEP RESPONSE OF A SECOND ORDER SYSTEM FOR VARIOUS VALUES OF ZETA Description: Damping ratio is a dimensionless measure describing how oscillations in a system decay after a disturbance. Many systems exhibit oscillatory behavior when they are disturbed from their position of static equilibrium. Software Code: clc; close all; clear zeta=[ ]; % Various damping ratio t=0:0.2:10; num=[0 0 25]; % Plotting time length % Numerator den1=[1 10*zeta(1) 25]; den2=[1 10*zeta(2) 25]; den3=[1 10*zeta(3) 25]; den4=[1 10*zeta(4) 25]; figure(1) [f1,t]=step(num,den1,t);plot(t,f1);hold on; % Step Response [f2,t]=step(num,den2,t);plot(t,f2);hold on; [f3,t]=step(num,den3,t);plot(t,f3);hold on; [f4,t]=step(num,den4,t);plot(t,f4);hold on; leg('zeta=0.0,system is undamped','zeta=0.6,under Damped','zeta=1.0,Critically damped','zeta=1.5,over damped') title('step response for various values of zeta') 15

16 Simulation Results: Figure 2.a: Step Response of the given system for different damping ratio 16

17 EXP.2 EFFECT OF P, PD, PI AND PID CONTROLLER Aim & Description: To obtain step response of the given system and evaluate the effect P,PD,PI and PID controllers. A controller is a device, historically using mechanical, hydraulic, pneumatic or electronic techniques often in combination, but more recently in the form of a microprocessor or computer, which monitors and physically alters the operating conditions of a given dynamical system. G s) 0.5s ( 3 Software Code: 1 1s 4 clc; clear; close all; sys.num=[1]; % Numerator of the system is defined as a structure sys.den=[ ]; % Denominator of the system is defined as a structure sys1=tf(sys) sys5.num=[1]; sys5.den=[1]; % Print transfer function and store it in sys1. %Numerator of unity feedback system %Denominator of unity feedback system [f,g]=feedback(sys,sys5) [z,t]=step(g); % Gives transfer function of the system with unity feedback % Step response of the system subplot(2,3,1);plot(t,z);grid on; title('step response of given system'); %Proportional controller kp=10; sys.num=kp*sys.num; % Numerator augmented with P controller sys2=tf(sys); [f,g]=feedback(sys,sys5) [z,t]=step(g); subplot(2,3,2); plot(t,z);grid on; title('proportional contol Kp=10') k=dcgain(sys) % DC gain of the system ( s=0) 17

18 essp=1/(1+k) % % PD controler Kd=10; numc=[kd*kp kp]; %Transfer function of a PD controller is [ Kp+Kd*s] sys.num=conv(numc,sys.num); % Numerator augmented with PD controller sys3=tf(sys); [f,g]=feedback(sys,sys5) [m,t]=step(g); subplot(2,3,3);plot(t,m);grid on; title('pd control Kp=10 and Kd=10') %PI controller ki=10; sys.num=[kp ki*kp]; % %Transfer function of a PI controller is [ Kp+ ki*kp/s] deni=[1 0]; sys.den=conv(deni,sys.den); sys4=tf(sys) [f,g]=feedback(sys,sys5); [m,t]=step(g); subplot(2,3,4);plot(t,m);grid; k=dcgain(g) esspi=1/(1+k) title('pi control Kp=10 and Ki=10') % %PID controller sys.num=conv(numc,[1 ki]); % Numerator augmented with PID controller [Kp+Ki/s+Kd*s] sys3=tf(sys); [f,g]=feedback(sys,sys5); [m,t]=step(g); subplot(2,3,5);plot(t,m);grid; k=dcgain(g) 18

19 esspid=1/(1+k) title('pid control Kp=10,Ki=10 & kd=10') % Function defined for feedback function [f,g]=feedback(sys1,sys2) num1=sys1.num; %Numerator of the first system den1=sys1.den; %Denominator of the first system num2=sys2.num; %Numerator of the second system den2=sys2.den; %Denominator of the second system [num1,den2]=equal_length(num1,den2); % to make numerator and denominator equal length [den1,den2]=equal_length(den1,den2); [num1,num2]=equal_length(num1,num2); num_n=conv([num1],[den2]); %Numerator of the feedback system d1=conv([den1],[den2]); d2=conv([num1],[num2]); [d1 d2]=equal_length(d1,d2); den_n=d1+d2; % denominator of the feedback system G.num=num_n; G.den=den_n; f=tf(g); s1=find(g.num); s2=find(g.den); if s1(1)>1 G.num=[G.num(s1(1):length(G.num))]; % to avoid initial unwanted zeros in the numerator if s2(1)>1 G.den=[G.den(s2(1):length(G.den))]; % to avoid initial unwanted zeros in the denominator %Function defined to make numerator and denominator equal length function [num1,den1]=equal_length(num1,den1) g=abs(length(den1)-length(num1)); %Difference in the length of numerator and denominator % To make numerator equal length with denominator if length(den1)>length(num1) for i=length(num1):-1:1 num1(i+g)=num1(i); for l=1:g num1(l)=0; 19

20 % To make denominator equal length with numerator if length(num1)>length(den1) for i=length(den1):-1:1 den1(i+g)=den1(i); for l=1:g den1(l)=0; num1; den1; Simulation Results: Figure 2.a: Effect of P, PD, PI and PID controllers 20

21 EXP.3 ROOT LOCUS, BODE AND NYQUIST PLOT Aim & Description: 1) To sketch the root locus for the given transfer function 2) To sketch the nyquist plots for the given transfer function 3) To sketch the bode plots for the given transfer function Root locus analysis is a graphical method for examining how the roots of a system change with variation of a certain system parameter, commonly a gain within a feedback system. Nyquist plot is a representation of the vector response of a feedback system (especially an amplifier) as a complex graphical plot showing the relationship between feedback and gain. Bode plot is a graph of the frequency response of a system. It is usually a combination of a Bode magnitude plot, expressing the magnitude (usually in decibels) of the frequency response, and a Bode phase plot, expressing the phase shift. Both quantities are plotted against a horizontal axis proportional to the logarithm of frequency. Software Code: 1 G ( s) 3 2 s 5s 6s 0 clc; clear; close all; sys.num=[ ]; % Numerator of the system sys.den=[ ]; % Denominator of the system sys1=tf(sys); % Printing transfer function subplot(2,2,1) rlocus(sys); % root locus of the system title('root locus'); ylabel('imaginary Axis') % %Effect of adding poles sys.den=conv([1 10],sys.den); % Adding poles to the denominator sys2=tf(sys); subplot(2,2,2) rlocus(sys); % root locus of the system when extra poles are added title(' Effect of adding poles');ylabel('imaginary Axis') % %Effect of adding zeros 21

22 sys.num=conv([1 1],sys.num); % Adding zeros to the denominator sys.den=[ ]; sys3=tf(sys); subplot(2,2,3) rlocus(sys); % root locus of the system when poles are added title(' Effect of adding zeros in Root locus');ylabel('imaginary Axis') % % effect of k on the transient response k=10; t=0:0.01:20; G.num=[0 0 0 k] G.den=[1 5 6 k]; [z,t]=step(g); % Finding step response of the system subplot(2,2,4);xlabel('time');ylabel('amplitude') plot(t,z); grid on; title('effect of k on transient response'); % Function defined for rlocus function rlocus(sys) num=sys.num; den=sys.den; %% To make numerator and denominator equal length g=abs(length(den)-length(num)); if length(den)>length(num) % If denominator length is greater than numerator length for i=length(num):-1:1 num(i+g)=num(i); % shifting numerator coefficients to the right for l=1:g num(l)=0; % Apping zeros to the index where numerator coefficients originally existed 22

23 if length(num)>length(den) % If numerator length is greater than denominator length for i=length(den):-1:1 den(i+g)=den(i); % shifting denominator coefficients to the right for l=1:g den(l)=0; % Apping zeros to the index where denominator coefficients originally existed %%% d=roots(den); % Finding poles n=roots(num); % Finding zeros P=length(d); % Number of poles Z=length(n); % Number of zeros pzmap(num,den); % P-Z map of the given system grid on;hold on; i = 1; for k=0:0.1:30 r3=den+k*num; r2{i}=roots(r3); % Denominator of unity feedback system for various gain values % poles of the feedback system i = i+1; if P==4 && Z==0 % Special case for no zeros and 4 poles for k=0:5:1000 r3=den+k*num; r2{i}=roots(r3); i = i+1; z2=cell2mat(r2); % Conversion of cell to matrix 23

24 % Extraction of values from the matrix j=1; for k=1:length(d) for i=p+k:length(d):numel(z2) b(j)=z2(i); j=j+1; %------Plotting the extracted values for i=1:numel(b) p1=[real(b(i)),imag(b(i))]; p2=[real(b(i)),imag(b(i))]; % Define the first point to plot the root locus % Define the second point to plot the root locus theta = atan2( p2(2) - p1(2), p2(1) - p1(1)); %Define slope r = sqrt( (p2(1) - p1(1))^2 + (p2(2) - p1(2))^2); % Distance between first and second point line = 0:0.01: r; x = p1(1) + line*cos(theta); y = p1(2) + line*sin(theta); % set of x coordinates to plot root locus % set of y coordinates to plot root locus if k==1 plot(x,y,'cyan.'); % plotting different branches with different color hold on; if k==2 plot(x,y,'g.'); % plotting different branches with different color hold on; if k==3 plot(x,y,'r.'); % plotting different branches with different color hold on; if k==4 24

25 plot(x,y,'b.'); % plotting different branches with different color hold on; j=1; ; Simulation Results: Figure 3.a: Root locus & effect of adding zeros and poles % Bode Plot sys.num=[ ]; sys.den=[ ]; % Numerator of the system % denominator of the system w=logspace(-2,2,100); % Define frequency magnitude=1./(w.*sqrt(w.^2+3^2).*sqrt(w.^2+2^2)); % Magnitude expression of the given system mag_db=20*log10(magnitude); % Magnitude in db phase_rad=-atan(w/0)-atan(w/3)-atan(w/2); %Phase angle phase_deg=phase_rad*180/pi; %Phase angle in degree figure(2) subplot(2,1,1) 25

26 semilogx(w,mag_db) % Magnitude plot in semilog graph xlabel('frequency [rad/s]'),ylabel('magnitude [db]'),grid on; subplot(2,1,2) semilogx(w,phase_deg) % Phase plot xlabel('frequency [rad/s]'),ylabel('phase Angle [deg]'),grid on; %% Gain Margin [wgc,fval] = fsolve(@func,5) % gain crossover frequency gm=1./(wgc.*sqrt(wgc.^2+3^2).*sqrt(wgc.^2+2^2)) % Gain Margin % Phase margin j=1; for i=1:length(mag_db) if mag_db(i)>-0.2 && mag_db(i)<0.2 % setting a limit for finding wpm b(j)=(i); j=j+1; wpm=min(w(b)) % phase crossover frequency pm=(-atan(wpm/0)-atan(wpm/3)-atan(wpm/2))*180/pi+180 % Phase margin % Function defined for solving gain crossover frequency function w= func(w) f=-atan(w/0)-atan(w/3)-atan(w/2)+180; 26

27 Simulation results: Figure 3.b: Bode plot for the given system % Nyquist Plot clc; clear; close all; sys.num=[ ]; % Numerator of the given system sys.den=[ ]; % Denominator of the given system w=0:-0.01:-10; % Defining frequency for negative values for i=1:length(w) real_part(i)=-5*w(i)^2/(25*w(i)^4+(6*w(i)-w(i)^3)^2); % Real part of the given system for i=1:length(w) imag_part(i)=(w(i)^3-6*w(i))/(25*w(i)^4+(6*w(i)-w(i)^3)^2); % Imaginary part of the given system plot(real_part,imag_part,'b'); hold on; axis([ ]); % Define Axis fill(real_part(4),1.5, '^'); % To mark the Nyquist plot direction w=0:0.01:10; % Defining frequency for positive values 27

28 for i=1:length(w) real_part(i)=-5*w(i)^2/(25*w(i)^4+(6*w(i)-w(i)^3)^2); for i=1:length(w) imag_part(i)=(w(i)^3-6*w(i))/(25*w(i)^4+(6*w(i)-w(i)^3)^2); plot(real_part,imag_part,'b'); hold on; axis([ ]); % Define Axis xlabel('real Axis'); ylabel('imaginary Axis'); fill(real_part(4),-1.5, '^'); grid on; Figure 3.c: Nyquist plot for the given system 28

29 EXP.4 RELATION BETWEEN FREQUENCY RESPONSE AND TRANSIENT RESPONSE Aim & Description: To obtain the relation between frequency response and transient response Transient response or natural response is the response of a system to a change from an equilibrium or a steady state. Frequency response is the quantitative measure of the output spectrum of a system or device in response to a stimulus, and is used to characterize the dynamics of the system. It is a measure of magnitude and phase of the output as a function of frequency, in comparison to the input. Software Code: clc; clear; close all; zeta=0:0.01:0.8; num=[1]; % Different damping ratio values % Numerator den=conv([1 0],[0.1 1]) % Denominator g=tf(num,den); w=logspace(-1,3,100); % Frequency range in log scale magnitude=10./(w.*sqrt(w.^2+10^2)); mag_db=20*log10(magnitude); % Magnitude expression % Magnitude expression in decibel phase_rad=-atan(w/0)-atan(w/10); % Phase angle expression in radian phase_deg=phase_rad*180/pi; % Phase angle expression in degree figure(1) subplot(2,1,1) semilogx(w,mag_db) % Magnitude plot in semilog graph xlabel('frequency [rad/s]'),ylabel('magnitude [db]'),grid on; subplot(2,1,2) semilogx(w,phase_deg) % Phase plot in semi log graph xlabel('frequency [rad/s]'),ylabel('phase Angle [deg]'),grid on; %% Gain Margin [wgc,fval] = fsolve(@gain_margin,5) gm=1./(wgc.*sqrt(wgc.^2+10^2)) %---Gain margin 29

30 % Phase margin j=1; for i=1:length(mag_db) if mag_db(i)>-0.25 && mag_db(i)<0.25 % Selection criteria for finding the index of corresponding 0db frequency b(j)=(i); j=j+1; wpm=min(w(b)) % phase crossover frequency pm=(-atan(wpm/0)-atan(wpm/10))*180/pi+180 %---Phase margin for i=1:length(zeta) resonant_peak(i)=1/(2*zeta(i)*sqrt(1-zeta(i)^2)); % expression for finding resonant peak for i=1:length(zeta) max_overshoot(i)=exp(-pi*zeta(i)/sqrt(1-zeta(i)^2)); % expression for finding maximum overshoot for i=1:length(zeta) bandwidth(i)=1*sqrt((1-2*zeta(i)^2)+sqrt(4*zeta(i)^4-4*zeta(i)^2+2)); %expression for finding bandwidth figure(2) plot(zeta,resonant_peak) axis([ ]); hold on plot(zeta,max_overshoot) hold off; grid on; xlabel('zeta') ylabel('resonant peak,max.overshoot') figure(3) 30

31 plot(zeta,bandwidth); grid on; axis([ ]); xlabel('zeta') ylabel('bandwidth') %%%----Function for finding gain margin function w= gain_margin(w) f=-atan(w/0)-atan(w/10)+180; Simulation results: Phase crossover frequency, wpm = Gain margin, gm = Inf Phase margin, pm = Gain crossover frequency, wgc = 0 Figure 4.a: Bode plot of the given system 31

32 Figure 4.b: Resonant Peak, Max Overshoot and Damping ratio Figure 4.c: Bandwidth and damping ratio 32

Control System lab Experiments using Compose (Anna University Syllabus)

Control System lab Experiments using Compose (Anna University Syllabus) Control System lab Experiments using Compose (Anna University Syllabus) Author: Sijo George Reviewer: Sreeram Mohan Altair Engineering, Bangalore Version: 1 Date: 09/11/2016 1 CONTENTS EXP. 1: STABILITY

More information

R a) Compare open loop and closed loop control systems. b) Clearly bring out, from basics, Force-current and Force-Voltage analogies.

R a) Compare open loop and closed loop control systems. b) Clearly bring out, from basics, Force-current and Force-Voltage analogies. SET - 1 II B. Tech II Semester Supplementary Examinations Dec 01 1. a) Compare open loop and closed loop control systems. b) Clearly bring out, from basics, Force-current and Force-Voltage analogies..

More information

PID controllers. Laith Batarseh. PID controllers

PID controllers. Laith Batarseh. PID controllers Next Previous 24-Jan-15 Chapter six Laith Batarseh Home End The controller choice is an important step in the control process because this element is responsible of reducing the error (e ss ), rise time

More information

Outline. Classical Control. Lecture 5

Outline. Classical Control. Lecture 5 Outline Outline Outline 1 What is 2 Outline What is Why use? Sketching a 1 What is Why use? Sketching a 2 Gain Controller Lead Compensation Lag Compensation What is Properties of a General System Why use?

More information

LABORATORY INSTRUCTION MANUAL CONTROL SYSTEM I LAB EE 593

LABORATORY INSTRUCTION MANUAL CONTROL SYSTEM I LAB EE 593 LABORATORY INSTRUCTION MANUAL CONTROL SYSTEM I LAB EE 593 ELECTRICAL ENGINEERING DEPARTMENT JIS COLLEGE OF ENGINEERING (AN AUTONOMOUS INSTITUTE) KALYANI, NADIA CONTROL SYSTEM I LAB. MANUAL EE 593 EXPERIMENT

More information

(b) A unity feedback system is characterized by the transfer function. Design a suitable compensator to meet the following specifications:

(b) A unity feedback system is characterized by the transfer function. Design a suitable compensator to meet the following specifications: 1. (a) The open loop transfer function of a unity feedback control system is given by G(S) = K/S(1+0.1S)(1+S) (i) Determine the value of K so that the resonance peak M r of the system is equal to 1.4.

More information

KINGS COLLEGE OF ENGINEERING DEPARTMENT OF ELECTRONICS AND COMMUNICATION ENGINEERING

KINGS COLLEGE OF ENGINEERING DEPARTMENT OF ELECTRONICS AND COMMUNICATION ENGINEERING KINGS COLLEGE OF ENGINEERING DEPARTMENT OF ELECTRONICS AND COMMUNICATION ENGINEERING QUESTION BANK SUB.NAME : CONTROL SYSTEMS BRANCH : ECE YEAR : II SEMESTER: IV 1. What is control system? 2. Define open

More information

Control Systems. University Questions

Control Systems. University Questions University Questions UNIT-1 1. Distinguish between open loop and closed loop control system. Describe two examples for each. (10 Marks), Jan 2009, June 12, Dec 11,July 08, July 2009, Dec 2010 2. Write

More information

Bangladesh University of Engineering and Technology. EEE 402: Control System I Laboratory

Bangladesh University of Engineering and Technology. EEE 402: Control System I Laboratory Bangladesh University of Engineering and Technology Electrical and Electronic Engineering Department EEE 402: Control System I Laboratory Experiment No. 4 a) Effect of input waveform, loop gain, and system

More information

VALLIAMMAI ENGINEERING COLLEGE SRM Nagar, Kattankulathur

VALLIAMMAI ENGINEERING COLLEGE SRM Nagar, Kattankulathur VALLIAMMAI ENGINEERING COLLEGE SRM Nagar, Kattankulathur 603 203. DEPARTMENT OF ELECTRONICS & COMMUNICATION ENGINEERING SUBJECT QUESTION BANK : EC6405 CONTROL SYSTEM ENGINEERING SEM / YEAR: IV / II year

More information

9/9/2011 Classical Control 1

9/9/2011 Classical Control 1 MM11 Root Locus Design Method Reading material: FC pp.270-328 9/9/2011 Classical Control 1 What have we talked in lecture (MM10)? Lead and lag compensators D(s)=(s+z)/(s+p) with z < p or z > p D(s)=K(Ts+1)/(Ts+1),

More information

CHAPTER 7 : BODE PLOTS AND GAIN ADJUSTMENTS COMPENSATION

CHAPTER 7 : BODE PLOTS AND GAIN ADJUSTMENTS COMPENSATION CHAPTER 7 : BODE PLOTS AND GAIN ADJUSTMENTS COMPENSATION Objectives Students should be able to: Draw the bode plots for first order and second order system. Determine the stability through the bode plots.

More information

Homework 7 - Solutions

Homework 7 - Solutions Homework 7 - Solutions Note: This homework is worth a total of 48 points. 1. Compensators (9 points) For a unity feedback system given below, with G(s) = K s(s + 5)(s + 11) do the following: (c) Find the

More information

EE 4343/ Control System Design Project LECTURE 10

EE 4343/ Control System Design Project LECTURE 10 Copyright S. Ikenaga 998 All rights reserved EE 4343/5329 - Control System Design Project LECTURE EE 4343/5329 Homepage EE 4343/5329 Course Outline Design of Phase-lead and Phase-lag compensators using

More information

APPLICATIONS FOR ROBOTICS

APPLICATIONS FOR ROBOTICS Version: 1 CONTROL APPLICATIONS FOR ROBOTICS TEX d: Feb. 17, 214 PREVIEW We show that the transfer function and conditions of stability for linear systems can be studied using Laplace transforms. Table

More information

Exercises for lectures 13 Design using frequency methods

Exercises for lectures 13 Design using frequency methods Exercises for lectures 13 Design using frequency methods Michael Šebek Automatic control 2016 31-3-17 Setting of the closed loop bandwidth At the transition frequency in the open loop is (from definition)

More information

ELECTRONICS & COMMUNICATIONS DEP. 3rd YEAR, 2010/2011 CONTROL ENGINEERING SHEET 5 Lead-Lag Compensation Techniques

ELECTRONICS & COMMUNICATIONS DEP. 3rd YEAR, 2010/2011 CONTROL ENGINEERING SHEET 5 Lead-Lag Compensation Techniques CAIRO UNIVERSITY FACULTY OF ENGINEERING ELECTRONICS & COMMUNICATIONS DEP. 3rd YEAR, 00/0 CONTROL ENGINEERING SHEET 5 Lead-Lag Compensation Techniques [] For the following system, Design a compensator such

More information

LabVIEW 开发技术丛书 控制设计与仿真实战篇

LabVIEW 开发技术丛书 控制设计与仿真实战篇 LabVIEW 开发技术丛书 控制设计与仿真实战篇 录目录 Modeling DC Motor Position 1-8 Motor Position PID Control 9-18 Root Locus Design Method for Motor Position Control 19-28 Frequency Design Method for Motor Position Control

More information

Table of Laplacetransform

Table of Laplacetransform Appendix Table of Laplacetransform pairs 1(t) f(s) oct), unit impulse at t = 0 a, a constant or step of magnitude a at t = 0 a s t, a ramp function e- at, an exponential function s + a sin wt, a sine fun

More information

Outline. Classical Control. Lecture 1

Outline. Classical Control. Lecture 1 Outline Outline Outline 1 Introduction 2 Prerequisites Block diagram for system modeling Modeling Mechanical Electrical Outline Introduction Background Basic Systems Models/Transfers functions 1 Introduction

More information

CDS 101/110 Homework #7 Solution

CDS 101/110 Homework #7 Solution Amplitude Amplitude CDS / Homework #7 Solution Problem (CDS, CDS ): (5 points) From (.), k i = a = a( a)2 P (a) Note that the above equation is unbounded, so it does not make sense to talk about maximum

More information

Lab # 4 Time Response Analysis

Lab # 4 Time Response Analysis Islamic University of Gaza Faculty of Engineering Computer Engineering Dep. Feedback Control Systems Lab Eng. Tareq Abu Aisha Lab # 4 Lab # 4 Time Response Analysis What is the Time Response? It is an

More information

Systems Analysis and Control

Systems Analysis and Control Systems Analysis and Control Matthew M. Peet Arizona State University Lecture 24: Compensation in the Frequency Domain Overview In this Lecture, you will learn: Lead Compensators Performance Specs Altering

More information

INSTITUTE OF AERONAUTICAL ENGINEERING (Autonomous) Dundigal, Hyderabad

INSTITUTE OF AERONAUTICAL ENGINEERING (Autonomous) Dundigal, Hyderabad INSTITUTE OF AERONAUTICAL ENGINEERING (Autonomous) Dundigal, Hyderabad - 500 043 Electrical and Electronics Engineering TUTORIAL QUESTION BAN Course Name : CONTROL SYSTEMS Course Code : A502 Class : III

More information

Compensator Design to Improve Transient Performance Using Root Locus

Compensator Design to Improve Transient Performance Using Root Locus 1 Compensator Design to Improve Transient Performance Using Root Locus Prof. Guy Beale Electrical and Computer Engineering Department George Mason University Fairfax, Virginia Correspondence concerning

More information

CYBER EXPLORATION LABORATORY EXPERIMENTS

CYBER EXPLORATION LABORATORY EXPERIMENTS CYBER EXPLORATION LABORATORY EXPERIMENTS 1 2 Cyber Exploration oratory Experiments Chapter 2 Experiment 1 Objectives To learn to use MATLAB to: (1) generate polynomial, (2) manipulate polynomials, (3)

More information

INTRODUCTION TO DIGITAL CONTROL

INTRODUCTION TO DIGITAL CONTROL ECE4540/5540: Digital Control Systems INTRODUCTION TO DIGITAL CONTROL.: Introduction In ECE450/ECE550 Feedback Control Systems, welearnedhow to make an analog controller D(s) to control a linear-time-invariant

More information

2.010 Fall 2000 Solution of Homework Assignment 8

2.010 Fall 2000 Solution of Homework Assignment 8 2.1 Fall 2 Solution of Homework Assignment 8 1. Root Locus Analysis of Hydraulic Servomechanism. The block diagram of the controlled hydraulic servomechanism is shown in Fig. 1 e r e error + i Σ C(s) P(s)

More information

1 (20 pts) Nyquist Exercise

1 (20 pts) Nyquist Exercise EE C128 / ME134 Problem Set 6 Solution Fall 2011 1 (20 pts) Nyquist Exercise Consider a close loop system with unity feedback. For each G(s), hand sketch the Nyquist diagram, determine Z = P N, algebraically

More information

MAS107 Control Theory Exam Solutions 2008

MAS107 Control Theory Exam Solutions 2008 MAS07 CONTROL THEORY. HOVLAND: EXAM SOLUTION 2008 MAS07 Control Theory Exam Solutions 2008 Geir Hovland, Mechatronics Group, Grimstad, Norway June 30, 2008 C. Repeat question B, but plot the phase curve

More information

Index. Index. More information. in this web service Cambridge University Press

Index. Index. More information.  in this web service Cambridge University Press A-type elements, 4 7, 18, 31, 168, 198, 202, 219, 220, 222, 225 A-type variables. See Across variable ac current, 172, 251 ac induction motor, 251 Acceleration rotational, 30 translational, 16 Accumulator,

More information

Systems Analysis and Control

Systems Analysis and Control Systems Analysis and Control Matthew M. Peet Arizona State University Lecture 21: Stability Margins and Closing the Loop Overview In this Lecture, you will learn: Closing the Loop Effect on Bode Plot Effect

More information

Proportional plus Integral (PI) Controller

Proportional plus Integral (PI) Controller Proportional plus Integral (PI) Controller 1. A pole is placed at the origin 2. This causes the system type to increase by 1 and as a result the error is reduced to zero. 3. Originally a point A is on

More information

Controls Problems for Qualifying Exam - Spring 2014

Controls Problems for Qualifying Exam - Spring 2014 Controls Problems for Qualifying Exam - Spring 2014 Problem 1 Consider the system block diagram given in Figure 1. Find the overall transfer function T(s) = C(s)/R(s). Note that this transfer function

More information

Desired Bode plot shape

Desired Bode plot shape Desired Bode plot shape 0dB Want high gain Use PI or lag control Low freq ess, type High low freq gain for steady state tracking Low high freq gain for noise attenuation Sufficient PM near ω gc for stability

More information

CHAPTER 1 Basic Concepts of Control System. CHAPTER 6 Hydraulic Control System

CHAPTER 1 Basic Concepts of Control System. CHAPTER 6 Hydraulic Control System CHAPTER 1 Basic Concepts of Control System 1. What is open loop control systems and closed loop control systems? Compare open loop control system with closed loop control system. Write down major advantages

More information

R10 JNTUWORLD B 1 M 1 K 2 M 2. f(t) Figure 1

R10 JNTUWORLD B 1 M 1 K 2 M 2. f(t) Figure 1 Code No: R06 R0 SET - II B. Tech II Semester Regular Examinations April/May 03 CONTROL SYSTEMS (Com. to EEE, ECE, EIE, ECC, AE) Time: 3 hours Max. Marks: 75 Answer any FIVE Questions All Questions carry

More information

Step input, ramp input, parabolic input and impulse input signals. 2. What is the initial slope of a step response of a first order system?

Step input, ramp input, parabolic input and impulse input signals. 2. What is the initial slope of a step response of a first order system? IC6501 CONTROL SYSTEM UNIT-II TIME RESPONSE PART-A 1. What are the standard test signals employed for time domain studies?(or) List the standard test signals used in analysis of control systems? (April

More information

ECE382/ME482 Spring 2005 Homework 7 Solution April 17, K(s + 0.2) s 2 (s + 2)(s + 5) G(s) =

ECE382/ME482 Spring 2005 Homework 7 Solution April 17, K(s + 0.2) s 2 (s + 2)(s + 5) G(s) = ECE382/ME482 Spring 25 Homework 7 Solution April 17, 25 1 Solution to HW7 AP9.5 We are given a system with open loop transfer function G(s) = K(s +.2) s 2 (s + 2)(s + 5) (1) and unity negative feedback.

More information

LABORATORY INSTRUCTION MANUAL CONTROL SYSTEM II LAB EE 693

LABORATORY INSTRUCTION MANUAL CONTROL SYSTEM II LAB EE 693 LABORATORY INSTRUCTION MANUAL CONTROL SYSTEM II LAB EE 693 ELECTRICAL ENGINEERING DEPARTMENT JIS COLLEGE OF ENGINEERING (AN AUTONOMOUS INSTITUTE) KALYANI, NADIA EXPERIMENT NO : CS II/ TITLE : FAMILIARIZATION

More information

EC CONTROL SYSTEM UNIT I- CONTROL SYSTEM MODELING

EC CONTROL SYSTEM UNIT I- CONTROL SYSTEM MODELING EC 2255 - CONTROL SYSTEM UNIT I- CONTROL SYSTEM MODELING 1. What is meant by a system? It is an arrangement of physical components related in such a manner as to form an entire unit. 2. List the two types

More information

Automatic Control 2. Loop shaping. Prof. Alberto Bemporad. University of Trento. Academic year

Automatic Control 2. Loop shaping. Prof. Alberto Bemporad. University of Trento. Academic year Automatic Control 2 Loop shaping Prof. Alberto Bemporad University of Trento Academic year 21-211 Prof. Alberto Bemporad (University of Trento) Automatic Control 2 Academic year 21-211 1 / 39 Feedback

More information

STABILITY OF CLOSED-LOOP CONTOL SYSTEMS

STABILITY OF CLOSED-LOOP CONTOL SYSTEMS CHBE320 LECTURE X STABILITY OF CLOSED-LOOP CONTOL SYSTEMS Professor Dae Ryook Yang Spring 2018 Dept. of Chemical and Biological Engineering 10-1 Road Map of the Lecture X Stability of closed-loop control

More information

Performance of Feedback Control Systems

Performance of Feedback Control Systems Performance of Feedback Control Systems Design of a PID Controller Transient Response of a Closed Loop System Damping Coefficient, Natural frequency, Settling time and Steady-state Error and Type 0, Type

More information

UNIVERSITY OF BOLTON SCHOOL OF ENGINEERING BENG (HONS) IN BIOMEDICAL ENGINEERING SEMESTER 1 EXAMINATION 2017/2018 ADVANCED BIOMECHATRONIC SYSTEMS

UNIVERSITY OF BOLTON SCHOOL OF ENGINEERING BENG (HONS) IN BIOMEDICAL ENGINEERING SEMESTER 1 EXAMINATION 2017/2018 ADVANCED BIOMECHATRONIC SYSTEMS ENG0016 UNIVERSITY OF BOLTON SCHOOL OF ENGINEERING BENG (HONS) IN BIOMEDICAL ENGINEERING SEMESTER 1 EXAMINATION 2017/2018 ADVANCED BIOMECHATRONIC SYSTEMS MODULE NO: BME6003 Date: Friday 19 January 2018

More information

Lecture 5: Frequency domain analysis: Nyquist, Bode Diagrams, second order systems, system types

Lecture 5: Frequency domain analysis: Nyquist, Bode Diagrams, second order systems, system types Lecture 5: Frequency domain analysis: Nyquist, Bode Diagrams, second order systems, system types Venkata Sonti Department of Mechanical Engineering Indian Institute of Science Bangalore, India, 562 This

More information

10ES-43 CONTROL SYSTEMS ( ECE A B&C Section) % of Portions covered Reference Cumulative Chapter. Topic to be covered. Part A

10ES-43 CONTROL SYSTEMS ( ECE A B&C Section) % of Portions covered Reference Cumulative Chapter. Topic to be covered. Part A 10ES-43 CONTROL SYSTEMS ( ECE A B&C Section) Faculty : Shreyus G & Prashanth V Chapter Title/ Class # Reference Literature Topic to be covered Part A No of Hours:52 % of Portions covered Reference Cumulative

More information

Digital Control Systems

Digital Control Systems Digital Control Systems Lecture Summary #4 This summary discussed some graphical methods their use to determine the stability the stability margins of closed loop systems. A. Nyquist criterion Nyquist

More information

VALLIAMMAI ENGINEERING COLLEGE

VALLIAMMAI ENGINEERING COLLEGE VALLIAMMAI ENGINEERING COLLEGE SRM Nagar, Kattankulathur 603 203 DEPARTMENT OF ELECTRICAL AND ELECTRONICS ENGINEERING QUESTION BANK V SEMESTER IC650 CONTROL SYSTEMS Regulation 203 Academic Year 207 8 Prepared

More information

Lecture 5 Classical Control Overview III. Dr. Radhakant Padhi Asst. Professor Dept. of Aerospace Engineering Indian Institute of Science - Bangalore

Lecture 5 Classical Control Overview III. Dr. Radhakant Padhi Asst. Professor Dept. of Aerospace Engineering Indian Institute of Science - Bangalore Lecture 5 Classical Control Overview III Dr. Radhakant Padhi Asst. Professor Dept. of Aerospace Engineering Indian Institute of Science - Bangalore A Fundamental Problem in Control Systems Poles of open

More information

NADAR SARASWATHI COLLEGE OF ENGINEERING AND TECHNOLOGY Vadapudupatti, Theni

NADAR SARASWATHI COLLEGE OF ENGINEERING AND TECHNOLOGY Vadapudupatti, Theni NADAR SARASWATHI COLLEGE OF ENGINEERING AND TECHNOLOGY Vadapudupatti, Theni-625531 Question Bank for the Units I to V SE05 BR05 SU02 5 th Semester B.E. / B.Tech. Electrical & Electronics engineering IC6501

More information

= rad/sec. We can find the last parameter, T, from ωcg new

= rad/sec. We can find the last parameter, T, from ωcg new EE572 Solution to HW#22. Keep working on your project!! 1. Consider the following system: W(s) + T s =1 msec G lead (z) G zoh (z) 8 ( s+ 4) - a) Design a lead compensator, G lead (z), which meets the following

More information

] [ 200. ] 3 [ 10 4 s. [ ] s + 10 [ P = s [ 10 8 ] 3. s s (s 1)(s 2) series compensator ] 2. s command pre-filter [ 0.

] [ 200. ] 3 [ 10 4 s. [ ] s + 10 [ P = s [ 10 8 ] 3. s s (s 1)(s 2) series compensator ] 2. s command pre-filter [ 0. EEE480 Exam 2, Spring 204 A.A. Rodriguez Rules: Calculators permitted, One 8.5 sheet, closed notes/books, open minds GWC 352, 965-372 Problem (Analysis of a Feedback System) Consider the feedback system

More information

Control Systems Engineering ( Chapter 8. Root Locus Techniques ) Prof. Kwang-Chun Ho Tel: Fax:

Control Systems Engineering ( Chapter 8. Root Locus Techniques ) Prof. Kwang-Chun Ho Tel: Fax: Control Systems Engineering ( Chapter 8. Root Locus Techniques ) Prof. Kwang-Chun Ho kwangho@hansung.ac.kr Tel: 02-760-4253 Fax:02-760-4435 Introduction In this lesson, you will learn the following : The

More information

Engraving Machine Example

Engraving Machine Example Engraving Machine Example MCE44 - Fall 8 Dr. Richter November 24, 28 Basic Design The X-axis of the engraving machine has the transfer function G(s) = s(s + )(s + 2) In this basic example, we use a proportional

More information

FREQUENCY-RESPONSE DESIGN

FREQUENCY-RESPONSE DESIGN ECE45/55: Feedback Control Systems. 9 FREQUENCY-RESPONSE DESIGN 9.: PD and lead compensation networks The frequency-response methods we have seen so far largely tell us about stability and stability margins

More information

6.1 Sketch the z-domain root locus and find the critical gain for the following systems K., the closed-loop characteristic equation is K + z 0.

6.1 Sketch the z-domain root locus and find the critical gain for the following systems K., the closed-loop characteristic equation is K + z 0. 6. Sketch the z-domain root locus and find the critical gain for the following systems K (i) Gz () z 4. (ii) Gz K () ( z+ 9. )( z 9. ) (iii) Gz () Kz ( z. )( z ) (iv) Gz () Kz ( + 9. ) ( z. )( z 8. ) (i)

More information

Appendix A: Exercise Problems on Classical Feedback Control Theory (Chaps. 1 and 2)

Appendix A: Exercise Problems on Classical Feedback Control Theory (Chaps. 1 and 2) Appendix A: Exercise Problems on Classical Feedback Control Theory (Chaps. 1 and 2) For all calculations in this book, you can use the MathCad software or any other mathematical software that you are familiar

More information

Root Locus. Motivation Sketching Root Locus Examples. School of Mechanical Engineering Purdue University. ME375 Root Locus - 1

Root Locus. Motivation Sketching Root Locus Examples. School of Mechanical Engineering Purdue University. ME375 Root Locus - 1 Root Locus Motivation Sketching Root Locus Examples ME375 Root Locus - 1 Servo Table Example DC Motor Position Control The block diagram for position control of the servo table is given by: D 0.09 Position

More information

Dr Ian R. Manchester Dr Ian R. Manchester AMME 3500 : Root Locus

Dr Ian R. Manchester Dr Ian R. Manchester AMME 3500 : Root Locus Week Content Notes 1 Introduction 2 Frequency Domain Modelling 3 Transient Performance and the s-plane 4 Block Diagrams 5 Feedback System Characteristics Assign 1 Due 6 Root Locus 7 Root Locus 2 Assign

More information

Course roadmap. Step response for 2nd-order system. Step response for 2nd-order system

Course roadmap. Step response for 2nd-order system. Step response for 2nd-order system ME45: Control Systems Lecture Time response of nd-order systems Prof. Clar Radcliffe and Prof. Jongeun Choi Department of Mechanical Engineering Michigan State University Modeling Laplace transform Transfer

More information

Frequency Response Techniques

Frequency Response Techniques 4th Edition T E N Frequency Response Techniques SOLUTION TO CASE STUDY CHALLENGE Antenna Control: Stability Design and Transient Performance First find the forward transfer function, G(s). Pot: K 1 = 10

More information

Answers to multiple choice questions

Answers to multiple choice questions Answers to multiple choice questions Chapter 2 M2.1 (b) M2.2 (a) M2.3 (d) M2.4 (b) M2.5 (a) M2.6 (b) M2.7 (b) M2.8 (c) M2.9 (a) M2.10 (b) Chapter 3 M3.1 (b) M3.2 (d) M3.3 (d) M3.4 (d) M3.5 (c) M3.6 (c)

More information

Control Systems I Lecture 10: System Specifications

Control Systems I Lecture 10: System Specifications Control Systems I Lecture 10: System Specifications Readings: Guzzella, Chapter 10 Emilio Frazzoli Institute for Dynamic Systems and Control D-MAVT ETH Zürich November 24, 2017 E. Frazzoli (ETH) Lecture

More information

Frequency Response Analysis

Frequency Response Analysis Frequency Response Analysis Consider let the input be in the form Assume that the system is stable and the steady state response of the system to a sinusoidal inputdoes not depend on the initial conditions

More information

ECE382/ME482 Spring 2005 Homework 6 Solution April 17, (s/2 + 1) s(2s + 1)[(s/8) 2 + (s/20) + 1]

ECE382/ME482 Spring 2005 Homework 6 Solution April 17, (s/2 + 1) s(2s + 1)[(s/8) 2 + (s/20) + 1] ECE382/ME482 Spring 25 Homework 6 Solution April 17, 25 1 Solution to HW6 P8.17 We are given a system with open loop transfer function G(s) = 4(s/2 + 1) s(2s + 1)[(s/8) 2 + (s/2) + 1] (1) and unity negative

More information

Chapter 9: Controller design

Chapter 9: Controller design Chapter 9. Controller Design 9.1. Introduction 9.2. Effect of negative feedback on the network transfer functions 9.2.1. Feedback reduces the transfer function from disturbances to the output 9.2.2. Feedback

More information

MAK 391 System Dynamics & Control. Presentation Topic. The Root Locus Method. Student Number: Group: I-B. Name & Surname: Göksel CANSEVEN

MAK 391 System Dynamics & Control. Presentation Topic. The Root Locus Method. Student Number: Group: I-B. Name & Surname: Göksel CANSEVEN MAK 391 System Dynamics & Control Presentation Topic The Root Locus Method Student Number: 9901.06047 Group: I-B Name & Surname: Göksel CANSEVEN Date: December 2001 The Root-Locus Method Göksel CANSEVEN

More information

INSTITUTE OF AERONAUTICAL ENGINEERING Dundigal, Hyderabad ELECTRICAL AND ELECTRONICS ENGINEERING TUTORIAL QUESTION BANK

INSTITUTE OF AERONAUTICAL ENGINEERING Dundigal, Hyderabad ELECTRICAL AND ELECTRONICS ENGINEERING TUTORIAL QUESTION BANK Course Name Course Code Class Branch INSTITUTE OF AERONAUTICAL ENGINEERING Dundigal, Hyderabad -500 043 ELECTRICAL AND ELECTRONICS ENGINEERING TUTORIAL QUESTION BAN : CONTROL SYSTEMS : A50 : III B. Tech

More information

(a) Find the transfer function of the amplifier. Ans.: G(s) =

(a) Find the transfer function of the amplifier. Ans.: G(s) = 126 INTRDUCTIN T CNTR ENGINEERING 10( s 1) (a) Find the transfer function of the amplifier. Ans.: (. 02s 1)(. 001s 1) (b) Find the expected percent overshoot for a step input for the closed-loop system

More information

Due Wednesday, February 6th EE/MFS 599 HW #5

Due Wednesday, February 6th EE/MFS 599 HW #5 Due Wednesday, February 6th EE/MFS 599 HW #5 You may use Matlab/Simulink wherever applicable. Consider the standard, unity-feedback closed loop control system shown below where G(s) = /[s q (s+)(s+9)]

More information

Solutions. MathScript. So You Think You Can. Part III: Frequency Response HANS-PETTER HALVORSEN,

Solutions. MathScript. So You Think You Can. Part III: Frequency Response HANS-PETTER HALVORSEN, Telemark University College Department of Electrical Engineering, Information Technology and Cybernetics Solutions So You Think You Can HANS-PETTER HALVORSEN, 2011.10.05 MathScript Part III: Frequency

More information

Lab Experiment 2: Performance of First order and second order systems

Lab Experiment 2: Performance of First order and second order systems Lab Experiment 2: Performance of First order and second order systems Objective: The objective of this exercise will be to study the performance characteristics of first and second order systems using

More information

System Modeling: Motor position, θ The physical parameters for the dc motor are:

System Modeling: Motor position, θ The physical parameters for the dc motor are: Dept. of EEE, KUET, Sessional on EE 3202: Expt. # 2 2k15 Batch Experiment No. 02 Name of the experiment: Modeling of Physical systems and study of their closed loop response Objective: (i) (ii) (iii) (iv)

More information

SAMPLE SOLUTION TO EXAM in MAS501 Control Systems 2 Autumn 2015

SAMPLE SOLUTION TO EXAM in MAS501 Control Systems 2 Autumn 2015 FACULTY OF ENGINEERING AND SCIENCE SAMPLE SOLUTION TO EXAM in MAS501 Control Systems 2 Autumn 2015 Lecturer: Michael Ruderman Problem 1: Frequency-domain analysis and control design (15 pt) Given is a

More information

EE 422G - Signals and Systems Laboratory

EE 422G - Signals and Systems Laboratory EE 4G - Signals and Systems Laboratory Lab 9 PID Control Kevin D. Donohue Department of Electrical and Computer Engineering University of Kentucky Lexington, KY 40506 April, 04 Objectives: Identify the

More information

IC6501 CONTROL SYSTEMS

IC6501 CONTROL SYSTEMS DHANALAKSHMI COLLEGE OF ENGINEERING CHENNAI DEPARTMENT OF ELECTRICAL AND ELECTRONICS ENGINEERING YEAR/SEMESTER: II/IV IC6501 CONTROL SYSTEMS UNIT I SYSTEMS AND THEIR REPRESENTATION 1. What is the mathematical

More information

ECE 486 Control Systems

ECE 486 Control Systems ECE 486 Control Systems Spring 208 Midterm #2 Information Issued: April 5, 208 Updated: April 8, 208 ˆ This document is an info sheet about the second exam of ECE 486, Spring 208. ˆ Please read the following

More information

Contents. PART I METHODS AND CONCEPTS 2. Transfer Function Approach Frequency Domain Representations... 42

Contents. PART I METHODS AND CONCEPTS 2. Transfer Function Approach Frequency Domain Representations... 42 Contents Preface.............................................. xiii 1. Introduction......................................... 1 1.1 Continuous and Discrete Control Systems................. 4 1.2 Open-Loop

More information

EC6405 - CONTROL SYSTEM ENGINEERING Questions and Answers Unit - I Control System Modeling Two marks 1. What is control system? A system consists of a number of components connected together to perform

More information

Radar Dish. Armature controlled dc motor. Inside. θ r input. Outside. θ D output. θ m. Gearbox. Control Transmitter. Control. θ D.

Radar Dish. Armature controlled dc motor. Inside. θ r input. Outside. θ D output. θ m. Gearbox. Control Transmitter. Control. θ D. Radar Dish ME 304 CONTROL SYSTEMS Mechanical Engineering Department, Middle East Technical University Armature controlled dc motor Outside θ D output Inside θ r input r θ m Gearbox Control Transmitter

More information

CONTROL SYSTEMS ENGINEERING Sixth Edition International Student Version

CONTROL SYSTEMS ENGINEERING Sixth Edition International Student Version CONTROL SYSTEMS ENGINEERING Sixth Edition International Student Version Norman S. Nise California State Polytechnic University, Pomona John Wiley fir Sons, Inc. Contents PREFACE, vii 1. INTRODUCTION, 1

More information

Classify a transfer function to see which order or ramp it can follow and with which expected error.

Classify a transfer function to see which order or ramp it can follow and with which expected error. Dr. J. Tani, Prof. Dr. E. Frazzoli 5-059-00 Control Systems I (Autumn 208) Exercise Set 0 Topic: Specifications for Feedback Systems Discussion: 30.. 208 Learning objectives: The student can grizzi@ethz.ch,

More information

Frequency Response part 2 (I&N Chap 12)

Frequency Response part 2 (I&N Chap 12) Frequency Response part 2 (I&N Chap 12) Introduction & TFs Decibel Scale & Bode Plots Resonance Scaling Filter Networks Applications/Design Frequency response; based on slides by J. Yan Slide 3.1 Example

More information

EECS C128/ ME C134 Final Wed. Dec. 15, am. Closed book. Two pages of formula sheets. No calculators.

EECS C128/ ME C134 Final Wed. Dec. 15, am. Closed book. Two pages of formula sheets. No calculators. Name: SID: EECS C28/ ME C34 Final Wed. Dec. 5, 2 8- am Closed book. Two pages of formula sheets. No calculators. There are 8 problems worth points total. Problem Points Score 2 2 6 3 4 4 5 6 6 7 8 2 Total

More information

Chapter 2. Classical Control System Design. Dutch Institute of Systems and Control

Chapter 2. Classical Control System Design. Dutch Institute of Systems and Control Chapter 2 Classical Control System Design Overview Ch. 2. 2. Classical control system design Introduction Introduction Steady-state Steady-state errors errors Type Type k k systems systems Integral Integral

More information

Frequency response. Pavel Máša - XE31EO2. XE31EO2 Lecture11. Pavel Máša - XE31EO2 - Frequency response

Frequency response. Pavel Máša - XE31EO2. XE31EO2 Lecture11. Pavel Máša - XE31EO2 - Frequency response Frequency response XE3EO2 Lecture Pavel Máša - Frequency response INTRODUCTION Frequency response describe frequency dependence of output to input voltage magnitude ratio and its phase shift as a function

More information

EEL2216 Control Theory CT1: PID Controller Design

EEL2216 Control Theory CT1: PID Controller Design EEL6 Control Theory CT: PID Controller Design. Objectives (i) To design proportional-integral-derivative (PID) controller for closed loop control. (ii) To evaluate the performance of different controllers

More information

CDS 101/110a: Lecture 8-1 Frequency Domain Design

CDS 101/110a: Lecture 8-1 Frequency Domain Design CDS 11/11a: Lecture 8-1 Frequency Domain Design Richard M. Murray 17 November 28 Goals: Describe canonical control design problem and standard performance measures Show how to use loop shaping to achieve

More information

Root Locus Techniques

Root Locus Techniques 4th Edition E I G H T Root Locus Techniques SOLUTIONS TO CASE STUDIES CHALLENGES Antenna Control: Transient Design via Gain a. From the Chapter 5 Case Study Challenge: 76.39K G(s) = s(s+50)(s+.32) Since

More information

Massachusetts Institute of Technology Department of Mechanical Engineering Dynamics and Control II Design Project

Massachusetts Institute of Technology Department of Mechanical Engineering Dynamics and Control II Design Project Massachusetts Institute of Technology Department of Mechanical Engineering.4 Dynamics and Control II Design Project ACTIVE DAMPING OF TALL BUILDING VIBRATIONS: CONTINUED Franz Hover, 5 November 7 Review

More information

DIGITAL CONTROLLER DESIGN

DIGITAL CONTROLLER DESIGN ECE4540/5540: Digital Control Systems 5 DIGITAL CONTROLLER DESIGN 5.: Direct digital design: Steady-state accuracy We have spent quite a bit of time discussing digital hybrid system analysis, and some

More information

Analysis and Design of Control Systems in the Time Domain

Analysis and Design of Control Systems in the Time Domain Chapter 6 Analysis and Design of Control Systems in the Time Domain 6. Concepts of feedback control Given a system, we can classify it as an open loop or a closed loop depends on the usage of the feedback.

More information

EE 370L Controls Laboratory. Laboratory Exercise #7 Root Locus. Department of Electrical and Computer Engineering University of Nevada, at Las Vegas

EE 370L Controls Laboratory. Laboratory Exercise #7 Root Locus. Department of Electrical and Computer Engineering University of Nevada, at Las Vegas EE 370L Controls Laboratory Laboratory Exercise #7 Root Locus Department of Electrical an Computer Engineering University of Nevaa, at Las Vegas 1. Learning Objectives To emonstrate the concept of error

More information

DESIGN USING TRANSFORMATION TECHNIQUE CLASSICAL METHOD

DESIGN USING TRANSFORMATION TECHNIQUE CLASSICAL METHOD 206 Spring Semester ELEC733 Digital Control System LECTURE 7: DESIGN USING TRANSFORMATION TECHNIQUE CLASSICAL METHOD For a unit ramp input Tz Ez ( ) 2 ( z ) D( z) G( z) Tz e( ) lim( z) z 2 ( z ) D( z)

More information

Dynamic Compensation using root locus method

Dynamic Compensation using root locus method CAIRO UNIVERSITY FACULTY OF ENGINEERING ELECTRONICS & COMMUNICATIONS DEP. 3rd YEAR, 00/0 CONTROL ENGINEERING SHEET 9 Dynamic Compensation using root locus method [] (Final00)For the system shown in the

More information

Chapter 7: Time Domain Analysis

Chapter 7: Time Domain Analysis Chapter 7: Time Domain Analysis Samantha Ramirez Preview Questions How do the system parameters affect the response? How are the parameters linked to the system poles or eigenvalues? How can Laplace transforms

More information

Control of Manufacturing Processes

Control of Manufacturing Processes Control of Manufacturing Processes Subject 2.830 Spring 2004 Lecture #19 Position Control and Root Locus Analysis" April 22, 2004 The Position Servo Problem, reference position NC Control Robots Injection

More information

CHAPTER 5 : REDUCTION OF MULTIPLE SUBSYSTEMS

CHAPTER 5 : REDUCTION OF MULTIPLE SUBSYSTEMS CHAPTER 5 : REDUCTION OF MULTIPLE SUBSYSTEMS Objectives Students should be able to: Reduce a block diagram of multiple subsystems to a single block representing the transfer function from input to output

More information

Lecture 6 Classical Control Overview IV. Dr. Radhakant Padhi Asst. Professor Dept. of Aerospace Engineering Indian Institute of Science - Bangalore

Lecture 6 Classical Control Overview IV. Dr. Radhakant Padhi Asst. Professor Dept. of Aerospace Engineering Indian Institute of Science - Bangalore Lecture 6 Classical Control Overview IV Dr. Radhakant Padhi Asst. Professor Dept. of Aerospace Engineering Indian Institute of Science - Bangalore Lead Lag Compensator Design Dr. Radhakant Padhi Asst.

More information