ROBOTICS Laboratory Problem 02

Size: px
Start display at page:

Download "ROBOTICS Laboratory Problem 02"

Transcription

1 ROBOTICS Laboratory Problem 02 Basilio Bona DAUIN PoliTo Problem formulation The planar system illustrated in Figure 1 consists of a cart C sliding with or without friction along the horizontal rail; at the pivot point C the cart supports a double pendulum, whose rotation axes in C and A are perpendicular to the plane. The pendulum arms are massless, but a solid mass B is attached to the end of the second arm. Each revolute joint may be affected by a linear dissipative effect and may have an internal linear spring-like elastic element. Problem objectives: 1. prepare and test the kinematic model that simulates the system motion; direct and inverse position and velocity kinematic functions are required; 2. design one ore more controllers of increasing complexity and simulate them; design specifications are left to the student s choice. The nonlinear model of the system Given the three coordinates q 1 (t), q 2 (t), q 3 (t) illustrated in Figure 1, q 1 is a linear coordinate, while q 2 and q 3 are angular coordinates. The two masses have the following center-of-mass coordinates q 1 q 1 + L 1 s 2 + L 2 s 23 r C = 0 r B = L 1 c 2 L 2 c and the velocities q 1 q 1 + L 1 c 2 q 2 + L 2 c 23 ( q 2 + q 3 ) 1 L 1 c 2 + L 2 c 23 L 2 c 23 q 1 ṙ C = 0 ṙ B = L 1 s 2 q 2 + L 2 s 23 ( q 2 + q 3 ) = 0 L 1 s 2 + L 2 s 23 L 2 s 23 q } 0 {{ 0 } q 3 J 1

2 Lab Problem Since the system is planar, the Jacobian J is both geometric and analytic. The angular velocity of the mass B is ω(t) = [ 0 0 ( q 2 + q 3 ) ] T. Having assumed the symbolic structure below 1 a b J = 0 c d the matrix J T J can be computed as a b 1 a b J T J = a c 0 0 c d = a A C b d b C B where a(q 2, q 3 ) = L 1 c 2 + L 2 c 23 b(q 2, q 3 ) = L 2 c 23 c(q 2, q 3 ) = L 1 s 2 + L 2 s 23 d(q 2, q 3 ) = L 2 s 23 A(q 3 ) = a 2 + c 2 = L L L 1 L 2 c 3 B = b 2 + d 2 = L 2 2 C(q 3 ) = ab + cd = L L 1 L 2 c 3 where, as usual and The kinematic co-energy is s 2 = sin(q 2 ), c 2 = cos(q 2 ), s 23 = sin(q 2 + q 3 ), c 23 = cos(q 2 + q 3 ) s 23 = s 2 c 3 + c 2 s 3 c 23 = c 2 c 3 s 2 s 3 c 3 = s 2 s 23 + c 2 c 23 K = 1 2 { mc ṙ C 2 + m B ṙ B 2 + ω T Γ B ω } The computation of m C ṙ C 2, ṙ B 2 and ω T Γ B ω gives the following expressions ṙ C 2 = q 2 1 ṙ B 2 = q T J T J q = q A q B q a q 1 q 2 + 2b q 1 q 3 + 2C q 2 q 3 hence K = 1 2 { m C q 2 1+ ω T Γ B ω = Γ B,z ( q 2 + q 3 ) 2 m B [ q A q B q a q 1 q 2 + 2b q 1 q 3 + 2C q 2 q 3 ] + Γ B,z ( q 2 + q 3 ) 2 }

3 Lab Problem The potential energy is P = m B g T r B = m B ( G)( L 1 c 2 L 2 c 23 ) = m B Ga If the model presents elastic elements in the joint, one shall add another term P e P e = 1 2 ( ka q k B q 2 3) with the assumption that the spring rest length is zero. The dissipation function depends on the assumed model friction: if all elements are subject to linear friction, we can write D = 1 2 ( βc q β A q β B q 2 3) The symbols used. i.e., k A, k B, β C, β A, β B have the standard obvious meaning. Lagrange equations It is convenient to compute the various terms in order to derive the Lagrange equations. Velocity derivatives Time derivatives K q 1 = m C q 1 + m B ( q 1 + a q 2 + b q 3 ) = (m C + m B ) q 1 + m B (a q 2 + b q 3 ) K q 2 = m B (A q 2 + a q 1 + C q 3 ) + Γ B,z ( q 2 + q 3 ) K q 3 = m B (B q 3 + b q 1 + C q 2 ) + Γ B,z ( q 2 + q 3 ) d K dt q 1 d K dt q 2 d K dt q 3 ( = (m C + m B ) q 1 + m B a q 2 + da dt q 2 + b q 3 + db ) dt q 3 ( = m B A q 2 + da dt q 2 + a q 1 + da dt q 1 + C q 3 + dc ) dt q 3 + Γ B,z ( q 2 + q 3 ) ( = m B B q 3 + db dt q 3 + b q 1 + db dt q 1 + C q 2 + dc ) dt q 2 + Γ B,z ( q 2 + q 3 )

4 Lab Problem where da(q 2, q 3 ) dt db(q 2, q 3 ) dt da(q 3 ) dt db dt = 0 dc(q 3 ) dt = a q 2 q 2 + a q 3 q 3 = (L 1 s 2 + L 2 s 23 ) q 2 L 2 s 23 q 3 = a q 2 q 2 + a q 3 q 3 = L 2 s 23 ( q 2 + q 3 ) = A q 3 q 3 = 2L 1 L 2 s 3 q 3 = C q 3 q 3 = L 1 L 2 s 3 q 3 Coordinate derivatives Dissipation K q 1 = 0 K q 2 = m B (L 1 s 2 + L 2 s 23 ) q 1 q 2 m B L 2 s 23 q 1 q 3 K q 3 = m B (L 1 L 2 s 3 q L 2 s 23 q 1 q 2 + L 2 s 23 q 1 q 3 + L 1 L 2 s 3 q 2 q 3 ) P q 1 = 0 Generalized forces P = m B G(L 1 s 2 + L 2 s 23 ) + k A q 2 q 2 }{{} if present P = m B GL 2 s 23 + k B q 3 q 3 }{{} if present D q 1 = β C q 1 D q 2 = β A q 2 D q 3 = β B q 3

5 Lab Problem If an horizontal force f = [ f x 0 0 ] is applied to the cart, then F 1 = f x, F 2 = F 3 = 0 We recall that the generic i th Lagrange equation is written as Equation 1 d K K + P + D = F i dt q i q i q i q i (m C + m B ) q 1 + m B (L 1 c 2 + L 2 c 23 ) q 2 + m B L 2 c 23 q 3 + Equation 2 m B (L 1 s 2 + L 2 s 23 ) q 2 2 m B L 2 s 23 q 2 3 2m B L 2 s 23 q 2 q 3 + β C q 1 = f x (1) m B (L 1 c 2 + L 2 c 23 ) q 1 + [m B (L L L 1 L 2 c 3 ) + Γ B,z ] q 2 + Equation 3 + [m B (L L 1 L 2 c 3 ) + Γ B,z ] q 3 2m B L 1 L 2 s 3 q 2 q 3 m B L 1 L 2 s 3 q β A q 2 + k A q 2 = m B G(L 1 s 2 + L 2 s 23 ) (2) m B L 2 c 23 q 1 + [m B (L L 1 L 2 c 3 ) + Γ B,z ] q 2 + [m B L Γ B,z ] q 3 + m B L 1 L 2 s 3 q 2 2+ The three equations can be written in matrix form as + β B q 3 + k B q 3 = m B GL 2 s 23 (3) H (q) q + C ( q, q) q + B q + K q = f (4) where the matrix m C + m B m B (L 1 c 2 + L 2 c 23 ) m B L 2 c 23 H (q) = m B (L 1 c 2 + L 2 c 23 ) m B (L L L 1 L 2 c 3 ) + Γ B,z m B (L L 1 L 2 c 3 ) + Γ B,z m B L 2 c 23 m B (L L 1 L 2 c 3 ) + Γ B,z m B L Γ B,z is symmetric, positive definite, as expected, and represents the overall inertial characteristic of the system; it depends on the generalized coordinates q(t); B and K are simple constant diagonal matrices β C B = 0 β A 0 K = 0 0 β B 0 k A k B

6 Lab Problem representing friction and elastic properties of the system. The vector f includes external and gravity forces affecting the system The matrix f 1 f x f = f 2 = m B G(L 1 s 2 + L 2 s 23 ) f 3 m B GL 2 s 23 c 11 c 12 c 13 C ( q, q) = c 21 c 22 c 23 c 31 c 32 c 33 is more complex to compute, since it contains the terms that contribute to the Coriolis and centripetal acceleration. Take note to not confuse the cosine of a sum of two angles, written as c ij, and a generic element of the matrix C, written as c ij (italic). Considering H 11 (q) H 12 (q) H 13 (q) H (q) = H 21 (q) H 22 (q) H 23 (q) H 31 (q) H 32 (q) H 33 (q) each term c ij can be computed as (make reference to the course slides) c ij = k h ijk (q) q k where h ijk = 1 2 ( Hij q k + H ik q j are called Christoffel symbols of the first kind. As an example we can compute c 12 and c 23 as H ) jk = h ikj k q i c 12 = h 121 q 1 + h 122 q 2 + h 122 q 3 c 23 = h 231 q 1 + h 232 q 2 + h 232 q 3

7 Lab Problem where that gives ( h 121 = 1 H12 + H 11 H ) 21 = 0 2 q 1 q 2 q 1 ( h 122 = 1 H12 + H 12 H ) 22 = m 2 B L 1 s 2 m B L 2 s 23 q 2 q 2 q 1 ( h 123 = 1 H12 + H 13 H ) 23 = m 2 B L 2 s 23 q 3 q 2 q 1 ( h 231 = 1 H23 + H 21 H ) 31 = 1 2 q 1 q 3 q ( m 2 BL 2 s 23 + m B L 2 s 23 ) = 0 2 ( h 232 = 1 H23 + H 22 H ) 32 = 1 2 q 2 q 3 q ( 2m 2 BL 1 L 2 s 3 ) = m B L 1 L 2 s 3 2 ( h 233 = 1 H23 + H 23 H ) 33 = 1 2 q 3 q 3 q ( 2m 2 BL 1 L 2 s 3 ) = m B L 1 L 2 s 3 2 c 12 = (m B L 1 s 2 + m B L 2 s 23 ) q 2 m B L 2 s 23 q 3 c 23 = m B L 1 L 2 s 3 q 2 m B L 1 L 2 s 3 q 3 After performing all necessary computations, the matrix C is 0 m B (L 1 s 2 + L 2 s 23 ) q 2 m B L 2 s 23 q 3 m B L 2 s 23 q 2 m B L 2 s 23 q 3 C = 0 m B L 1 L 2 s 3 q 3 m B L 1 L 2 s 3 q 2 m B L 1 L 2 s 3 q 3 0 m B L 1 L 2 s 3 q 2 0 and it is evident that depends both on q(t) and q(t). Second-order differential equations Considering that the inertial matrix H (q) in eqn. (4) is always invertible for any q(t), we can write the following system of second order equations as q(t) = H (q) 1 (C ( q, q) q + B q + K q + f ) (5) This is the starting point for writing the state equations and use them for Matlab simulation.

8 Lab Problem Preparing the Matlab model State equations Assuming the states as x 1 q 1 x 2 q 2 x = x 3 x 4 = q 3 q 1 x 5 q 2 x 6 q 3 we can write the following first order nonlinear differential equations ẋ 1 = x 4 (6) ẋ 2 = x 5 (7) ẋ 3 = x 6 (8) ẋ 4 = q 1 from eqn. (1) ẋ 5 = q 2 from eqn. (2) ẋ 6 = q 3 from eqn. (3) and in particular the mass and Coriolis matrices become m C + m B m B (L 1 c 2 + L 2 c 23 ) m B L 2 c 23 H (x ) = m B (L 1 c 2 + L 2 c 23 ) m B (L L L 1 L 2 c 3 ) + Γ B,z m B (L L 1 L 2 c 3 ) + Γ B,z m B L 2 c 23 m B (L L 1 L 2 c 3 ) + Γ B,z m B L Γ B,z and 0 m B (L 1 s 2 + L 2 s 23 )x 5 m B L 2 s 23 x 6 m B L 2 s 23 x 5 m B L 2 s 23 x 6 C = m B L 2 s 3 x 6 m B L 1 L 2 s 3 x 6 m B L 1 L 2 s 3 x 5 m B L 1 L 2 s 3 x 6 0 m B L 1 L 2 s 3 x 5 0 where, now: Equation (1) becomes c 2 = cos (x 2 ), c 23 = cos (x 2 + x 3 ) H 11 ẋ 4 + H 12 ẋ 5 + H 13 ẋ 6 + C 11 x 4 + C 12 x 5 + C 13 x 6 + β C x 4 = f 1 Equation (2) becomes H 21 ẋ 4 + H 22 ẋ 5 + H 23 ẋ 6 + C 21 x 4 + C 22 x 5 + C 23 x 6 + β A x 5 + k A x 2 = f 2 Equation (3) becomes H 31 ẋ 4 + H 32 ẋ 5 + H 33 ẋ 6 + C 31 x 4 + C 32 x 5 + C 33 x 6 + β B x 6 + k B x 3 = f 3

9 Lab Problem These three equations together with the previous equations (6-8), can be written in matrix form as H t ẋ + C t x + B t x + K t x = f t where H t = H 11 H 12 H H 21 H 22 H H 31 H 32 H 33 and Solutions B t = β C β A β B C t = C 11 C 12 C C 21 C 22 C C 31 C 32 C K t = k A k B We solve this system of six nonlinear differential equations using two methods: 0 0 f t = 0 f 1 f 2 f 3 1. a MATLAB function, namely ode45, that is described in details at mathworks.com/help/matlab/ref/ode45.html and 2. a Simulink model. (9) (10) MATLAB function The MATLAB function ode45 solves nonstiff differential equations, with the following call: [T,X] = ode45(@odefun,tspan,x0) This MATLAB function integrates the system of differential equations x = f(t, x) from initial time t0 to final time tf with initial conditions x0 and tspan = [t0 tf]; in our case we are interested in solving a time derivative ẋ = f(t, x). odefun is the generic name of the function (and the file that contains it) that one shall prepare to performs the computation of the required derivative. The function used to solve this problem is called diff eq cart and its listing is the following

10 Lab Problem function dx = diff_eq_cart(t,x) % Differential function to be integrated % The mass matrix must be inverted here global Bmat Kmat Cmat Mmat force Cmat11 = zeros(3); Cmat12 = -eye(3); Cmat21 = zeros(3); Cmat22 = coriolis(x); Cmat=[Cmat11 Cmat12; Cmat21 Cmat22]; force = zeros(6,1); force(4:6) = external_force(x); Mmat = mass6(0,x); Minv = inv(mmat); dx = Minv*(-(Cmat+Bmat+Kmat)*x+force); where x present state 6 1 dx computed state derivative 6 1 Bmat Friction coefficients matrix 6 6 Cmat Coriolis terms matrix 6 6 Kmat Elastic coefficients matrix 6 6 Mmat Mass matrix 6 6 Minv Mass matrix inverse 6 6 force Force vector 6 1 The algorithm is quite simple; it starts building the various matrices involved in eqn. 5, and then compute the derivative dx; notice that the input parameter t is not used, but is required by the ode45 function. The ode45 function is called in the main program, listed here % Matlab_Problem_02 % x =f(x) % % Set system parameters and data

11 Lab Problem clear all global m_c m_b L1 L2 Gz Bmat Kmat Cmat Mmat Grav x0 fx force m_c=200; % cart mass m_b=2; % ball mass L1=1; % Link 1 length L2=1; % Link 2 length Gz=1; % Inertia moment of the mas B fx=0; % applied horizontal force k_a=0; % elastic constant link 1 k_b=0; % elastic constant link 1 beta_c=0; % friction constant cart beta_a=10; % friction constant link 1 beta_b=10; % friction constant link 2 Grav=10; % gravity acceleration Tinitial = 0; Tfinal = 10; x0=[0 0 pi/ ]; % initial state Bmat=zeros(6); Kmat=zeros(6); Bmat(4,4)=beta_C; Bmat(5,5)=beta_A; Bmat(6,6)=beta_B; Kmat(5,5)=k_A; Kmat(6,6)=k_B; [T,X]=ode45(@diff_eq_cart,[Tinitial Tfinal],x0);... Two matrices, namely Bmat and Kmat in (10) are constant and can be computed once for all in the main program, while Mmat, Cmat and force in (9) are state-dependent and must be computed inside diff eq cart. In particular Mmat is computed by the MATLAB function mass6

12 Lab Problem function Mmat = mass6(t,x) % Mass Matrix 6x6 global m_c m_b L1 L2 Gz Mmat x1 = x(1); x2 = x(2); x3 = x(3); x4 = x(4); x5 = x(5); x6 = x(6); x23 = x2+x3; H(1,1) = m_c+m_b; H(1,2) = m_b*(l1*cos(x2) + L2*cos(x23)); H(1,3) = m_b*l2*cos(x23); H(2,1) = H(1,2); H(2,2) = m_b*(l1^2 + L2^2 + 2*L1*L2*cos(x3)) + Gz; H(2,3) = m_b*(l2^2 + L1*L2*cos(x3)) + Gz; H(3,1) = H(1,3); H(3,2) = H(2,3); H(3,3) = m_b*l2^2 + Gz; M11 = eye(3); M12 = zeros(3); M21 = zeros(3); M22 = H; Mmat=[M11 M12; M21 M22]; Cmat is computed by the MATLAB function coriolis function Cmat = coriolis(x) global m_b L1 L2 Cmat = eye(3); q2 = x(2);

13 Lab Problem q3 = x(3); qp2 = x(5); qp3 = x(6); q23 = q2+q3; qp23 = qp2+qp3; Cmat(1,1) = 0; Cmat(2,1) = 0; Cmat(3,1) = 0; Cmat(1,2) = -m_b*l2*sin(q23)*qp23-m_b*l1*sin(q2)*qp2; Cmat(2,2) = -m_b*l1*l2*sin(q3)*qp3; Cmat(3,2) = m_b*l1*l2*sin(q3)*qp2; Cmat(1,3) = -m_b*l2*sin(q23)*qp23; Cmat(2,3) = -m_b*l2*l2*sin(q3)*qp23; Cmat(3,3) = 0; force is computed by the MATLAB function external force function Force = external_force(x) % Force vector computation global m_b L1 L2 Grav fx Force=zeros(3,1); q2 = x(2); q3 = x(3); q23 = q2+q3; Force(1) = fx; Force(2) = -m_b*grav*(l1* sin(q2) + L2* sin(q23)); Force(3) = -m_b*grav*l2*sin(q23); The structure of these three functions is such that they can be used also in the SIMULINK approach, as specified in the next section. Results Using the parameters initially set in MatlabProblem 02, namely,

14 Lab Problem m_c=200; % cart mass m_b=2; % ball mass L1=1; % Link 1 length L2=1; % Link 2 length Gz=1; % Inertia moment of the mas B fx=0; % applied horizontal force k_a=0; % elastic constant link 1 k_b=0; % elastic constant link 1 beta_c=0; % friction constant cart beta_a=10; % friction constant link 1 beta_b=10; % friction constant link 2 Grav=10; % gravity acceleration x0=[0 0 pi/ ]; % initial state Tinitial = 0; % initial time Tfinal = 10; % final time The simulation computes the time history reported in Figure 1. One can see that the behaviour is approximately linear. The only initial non-zero state is x 3, i.e., the angle of the second link. After a short transient the angle goes to zero due to the presence of joint frictions; the cart position x 3 evolves from zero to a non-zero value (approx m ) due to the effect of the torques transmitted by the two revolute joints. If the mass m B is increased to m B = 20, as in m_c=200; % cart mass m_b=20; % ball mass L1=1; % Link 1 length L2=1; % Link 2 length Gz=1; % Inertia moment of the mas B fx=0; % applied horizontal force k_a=0; % elastic constant link 1 k_b=0; % elastic constant link 1 beta_c=0; % friction constant cart beta_a=10; % friction constant link 1 beta_b=10; % friction constant link 2 Grav=10; % gravity acceleration x0=[0 0 pi/ ]; % initial state Tinitial = 0; % initial time Tfinal = 10; % final time the states change as reported in Figure 2.

15 Lab Problem Simulink The same results can be achieved using the Simulink block-based approach; it represents a good exercise, even if the simulation time is considerably longer than that of the previous approach. Figure 3 gives the general overview of the Sim Problem 02 Simulink model, where six Sections or sub-models have been identified Section 1 models the integrators with their initial states x 0 ; the states are collected in a vector called X all. Section 2 contains the data blocks of the various parameters; this is a method to make them global, i.e., available to all parts of the model. Section 3 is a visual aid for the user who has a direct knowledge of the most relevant parameters; this part can be omitted without damage. Section 4 block Matrix computation contains the code required to compute the various state-dependent matrices; its content is show in Figure 4; it contains three Matlab function blocks, whose listing follows ================================================================== function Cmat = fcn_coriolis(x) global m_b L1 L2 Cmat = eye(3); q2 = x(2); q3 = x(3); qp2 = x(5); qp3 = x(6); q23 = q2+q3; qp23 = qp2+qp3; Cmat(1,1) = 0; Cmat(2,1) = 0; Cmat(3,1) = 0; Cmat(1,2) = -m_b*l2*sin(q23)*qp23-m_b*l1*sin(q2)*qp2; Cmat(2,2) = -m_b*l1*l2*sin(q3)*qp3; Cmat(3,2) = m_b*l1*l2*sin(q3)*qp2; Cmat(1,3) = -m_b*l2*sin(q23)*qp23; Cmat(2,3) = -m_b*l2*l2*sin(q3)*qp23; Cmat(3,3) = 0; ================================================================== function Mmat = fcn_mass(x) global m_c m_b L1 L2 Gz

16 Lab Problem Mmat = eye(3); q2 = x(2); q3 = x(3); q23 = q2+q3; Mmat(1,1) = m_c+m_b; Mmat(2,1) = m_b*(l1*cos(q2) + L2*cos(q23)); Mmat(3,1) = m_b*l2*cos(q23); Mmat(1,2) = Mmat(2,1); Mmat(2,2) = m_b*(l1^2 + L2^2 + 2*L1*L2*cos(q3)) + Gz; Mmat(3,2) = m_b*(l2^2 + L1*L2*cos(q3)) + Gz; Mmat(1,3) = Mmat(3,1); Mmat(2,3) = Mmat(3,2); Mmat(3,3) = m_b*l2^2 + Gz; ================================================================== function Force = fcn_force(x) global m_b L1 L2 Grav fx Force=zeros(3,1); q2 = x(2); q3 = x(3); q23 = q2+q3; Force(1) = fx; Force(2) = -m_b*grav*(l1* sin(q2) + L2* sin(q23)); Force(3) = -m_b*grav*l2*sin(q23); ================================================================== Section 5 block Nonlinear equations (see Figure 5) contains the model that produces the three accelerations, namely ẋ 4 = q 1, ẋ 5 = q 2 and ẋ 6 = q 3. Section 6 block Signal scopes (see Figure 6) contains the six scopes to visualize the states time history and the pipeline to file and workspace of the six states. The results of the simulation are presented in Figure 7; as one can see, comparing them with those presented in Figure 1 shows that they are equal, at least qualitatively. To verify that they are the same, we used the data passed to MATLAB by the X states block in the Nonlinear equations block. Unfortunately the number of data points generated by the two approaches are different; MATLAB produces 779 time values, while Simulink only 181. The comparison is made plotting both on a common plot, as shown in Figure 8. Other more sophisticated approaches, able to compute the error between the two data set are possible, but this point will not be investigated here.

17 Lab Problem Figure 1: Problem 2: choice of q i.

18 25 FIGURES Matlab_Problem_02 Figure 1: Time history of the states with m_b=2.

19 Figure 2:. Time history of the states with m_b=20. 25

20 25 FIGURES Sim_Problem_02 Figure 3: The block structure for simulation.

21 Figure 4: Sub-model block 4: matrix computation 25

22 Figure 5: Sub-model block 5: the nonlinear equations. 25

23 Figure 6: Sub-model block 6: the signal scopes. 25

24 Figure 7: Time history of the states with m_b=2; compare with Figure 1 25

25 Figure 8: Time history of both states with m_b=2; MATLAB (+), SIMULINK (o) 25

MSMS Matlab Problem 02

MSMS Matlab Problem 02 MSMS 2014-2015 Matlab Problem 02 Basilio Bona DAUIN PoliTo Problem formulation The planar system illustrated in Figure 1 consists of a cart C sliding with friction along the horizontal rail; the cart supports

More information

MSMS Basilio Bona DAUIN PoliTo

MSMS Basilio Bona DAUIN PoliTo MSMS 214-215 Basilio Bona DAUIN PoliTo Problem 2 The planar system illustrated in Figure 1 consists of a bar B and a wheel W moving (no friction, no sliding) along the bar; the bar can rotate around an

More information

Dynamics. Basilio Bona. Semester 1, DAUIN Politecnico di Torino. B. Bona (DAUIN) Dynamics Semester 1, / 18

Dynamics. Basilio Bona. Semester 1, DAUIN Politecnico di Torino. B. Bona (DAUIN) Dynamics Semester 1, / 18 Dynamics Basilio Bona DAUIN Politecnico di Torino Semester 1, 2016-17 B. Bona (DAUIN) Dynamics Semester 1, 2016-17 1 / 18 Dynamics Dynamics studies the relations between the 3D space generalized forces

More information

Artificial Intelligence & Neuro Cognitive Systems Fakultät für Informatik. Robot Dynamics. Dr.-Ing. John Nassour J.

Artificial Intelligence & Neuro Cognitive Systems Fakultät für Informatik. Robot Dynamics. Dr.-Ing. John Nassour J. Artificial Intelligence & Neuro Cognitive Systems Fakultät für Informatik Robot Dynamics Dr.-Ing. John Nassour 25.1.218 J.Nassour 1 Introduction Dynamics concerns the motion of bodies Includes Kinematics

More information

System Simulation using Matlab

System Simulation using Matlab EE4314 Fall 2008 System Simulation using Matlab The purpose of this laboratory work is to provide experience with the Matlab software for system simulation. The laboratory work contains a guide for solving

More information

Multibody simulation

Multibody simulation Multibody simulation Dynamics of a multibody system (Euler-Lagrange formulation) Dimitar Dimitrov Örebro University June 16, 2012 Main points covered Euler-Lagrange formulation manipulator inertia matrix

More information

Lecture Note 12: Dynamics of Open Chains: Lagrangian Formulation

Lecture Note 12: Dynamics of Open Chains: Lagrangian Formulation ECE5463: Introduction to Robotics Lecture Note 12: Dynamics of Open Chains: Lagrangian Formulation Prof. Wei Zhang Department of Electrical and Computer Engineering Ohio State University Columbus, Ohio,

More information

Rigid Manipulator Control

Rigid Manipulator Control Rigid Manipulator Control The control problem consists in the design of control algorithms for the robot motors, such that the TCP motion follows a specified task in the cartesian space Two types of task

More information

Case Study: The Pelican Prototype Robot

Case Study: The Pelican Prototype Robot 5 Case Study: The Pelican Prototype Robot The purpose of this chapter is twofold: first, to present in detail the model of the experimental robot arm of the Robotics lab. from the CICESE Research Center,

More information

Review: control, feedback, etc. Today s topic: state-space models of systems; linearization

Review: control, feedback, etc. Today s topic: state-space models of systems; linearization Plan of the Lecture Review: control, feedback, etc Today s topic: state-space models of systems; linearization Goal: a general framework that encompasses all examples of interest Once we have mastered

More information

28. Pendulum phase portrait Draw the phase portrait for the pendulum (supported by an inextensible rod)

28. Pendulum phase portrait Draw the phase portrait for the pendulum (supported by an inextensible rod) 28. Pendulum phase portrait Draw the phase portrait for the pendulum (supported by an inextensible rod) θ + ω 2 sin θ = 0. Indicate the stable equilibrium points as well as the unstable equilibrium points.

More information

q 1 F m d p q 2 Figure 1: An automated crane with the relevant kinematic and dynamic definitions.

q 1 F m d p q 2 Figure 1: An automated crane with the relevant kinematic and dynamic definitions. Robotics II March 7, 018 Exercise 1 An automated crane can be seen as a mechanical system with two degrees of freedom that moves along a horizontal rail subject to the actuation force F, and that transports

More information

In this section of notes, we look at the calculation of forces and torques for a manipulator in two settings:

In this section of notes, we look at the calculation of forces and torques for a manipulator in two settings: Introduction Up to this point we have considered only the kinematics of a manipulator. That is, only the specification of motion without regard to the forces and torques required to cause motion In this

More information

Advanced Robotic Manipulation

Advanced Robotic Manipulation Advanced Robotic Manipulation Handout CS37A (Spring 017) Solution Set #3 Problem 1 - Inertial properties In this problem, you will explore the inertial properties of a manipulator at its end-effector.

More information

Exercise 1b: Differential Kinematics of the ABB IRB 120

Exercise 1b: Differential Kinematics of the ABB IRB 120 Exercise 1b: Differential Kinematics of the ABB IRB 120 Marco Hutter, Michael Blösch, Dario Bellicoso, Samuel Bachmann October 5, 2016 Abstract The aim of this exercise is to calculate the differential

More information

Introduction to centralized control

Introduction to centralized control ROBOTICS 01PEEQW Basilio Bona DAUIN Politecnico di Torino Control Part 2 Introduction to centralized control Independent joint decentralized control may prove inadequate when the user requires high task

More information

Kinematics. Chapter Multi-Body Systems

Kinematics. Chapter Multi-Body Systems Chapter 2 Kinematics This chapter first introduces multi-body systems in conceptual terms. It then describes the concept of a Euclidean frame in the material world, following the concept of a Euclidean

More information

Physics for Scientists and Engineers 4th Edition, 2017

Physics for Scientists and Engineers 4th Edition, 2017 A Correlation of Physics for Scientists and Engineers 4th Edition, 2017 To the AP Physics C: Mechanics Course Descriptions AP is a trademark registered and/or owned by the College Board, which was not

More information

Modeling and Experimentation: Compound Pendulum

Modeling and Experimentation: Compound Pendulum Modeling and Experimentation: Compound Pendulum Prof. R.G. Longoria Department of Mechanical Engineering The University of Texas at Austin Fall 2014 Overview This lab focuses on developing a mathematical

More information

Robotics. Dynamics. Marc Toussaint U Stuttgart

Robotics. Dynamics. Marc Toussaint U Stuttgart Robotics Dynamics 1D point mass, damping & oscillation, PID, dynamics of mechanical systems, Euler-Lagrange equation, Newton-Euler recursion, general robot dynamics, joint space control, reference trajectory

More information

MEM04: Rotary Inverted Pendulum

MEM04: Rotary Inverted Pendulum MEM4: Rotary Inverted Pendulum Interdisciplinary Automatic Controls Laboratory - ME/ECE/CHE 389 April 8, 7 Contents Overview. Configure ELVIS and DC Motor................................ Goals..............................................3

More information

Hong Kong Institute of Vocational Education (Tsing Yi) Higher Diploma in Civil Engineering Structural Mechanics. Chapter 2 SECTION PROPERTIES

Hong Kong Institute of Vocational Education (Tsing Yi) Higher Diploma in Civil Engineering Structural Mechanics. Chapter 2 SECTION PROPERTIES Section Properties Centroid The centroid of an area is the point about which the area could be balanced if it was supported from that point. The word is derived from the word center, and it can be though

More information

Dynamics of Open Chains

Dynamics of Open Chains Chapter 9 Dynamics of Open Chains According to Newton s second law of motion, any change in the velocity of a rigid body is caused by external forces and torques In this chapter we study once again the

More information

Kinematics. Basilio Bona. Semester 1, DAUIN Politecnico di Torino. B. Bona (DAUIN) Kinematics Semester 1, / 15

Kinematics. Basilio Bona. Semester 1, DAUIN Politecnico di Torino. B. Bona (DAUIN) Kinematics Semester 1, / 15 Kinematics Basilio Bona DAUIN Politecnico di Torino Semester 1, 2016-17 B. Bona (DAUIN) Kinematics Semester 1, 2016-17 1 / 15 Introduction The kinematic quantities used to represent a body frame are: position

More information

Robotics: Tutorial 3

Robotics: Tutorial 3 Robotics: Tutorial 3 Mechatronics Engineering Dr. Islam Khalil, MSc. Omar Mahmoud, Eng. Lobna Tarek and Eng. Abdelrahman Ezz German University in Cairo Faculty of Engineering and Material Science October

More information

Chapter 14 Periodic Motion

Chapter 14 Periodic Motion Chapter 14 Periodic Motion 1 Describing Oscillation First, we want to describe the kinematical and dynamical quantities associated with Simple Harmonic Motion (SHM), for example, x, v x, a x, and F x.

More information

Chapter 12. Recall that when a spring is stretched a distance x, it will pull back with a force given by: F = -kx

Chapter 12. Recall that when a spring is stretched a distance x, it will pull back with a force given by: F = -kx Chapter 1 Lecture Notes Chapter 1 Oscillatory Motion Recall that when a spring is stretched a distance x, it will pull back with a force given by: F = -kx When the mass is released, the spring will pull

More information

System simulation using Matlab, state plane plots

System simulation using Matlab, state plane plots System simulation using Matlab, state plane plots his lab is mainly concerned with making state plane (also referred to as phase plane ) plots for various linear and nonlinear systems with two states he

More information

Robotics. Dynamics. University of Stuttgart Winter 2018/19

Robotics. Dynamics. University of Stuttgart Winter 2018/19 Robotics Dynamics 1D point mass, damping & oscillation, PID, dynamics of mechanical systems, Euler-Lagrange equation, Newton-Euler, joint space control, reference trajectory following, optimal operational

More information

Kinematics. Basilio Bona. October DAUIN - Politecnico di Torino. Basilio Bona (DAUIN - Politecnico di Torino) Kinematics October / 15

Kinematics. Basilio Bona. October DAUIN - Politecnico di Torino. Basilio Bona (DAUIN - Politecnico di Torino) Kinematics October / 15 Kinematics Basilio Bona DAUIN - Politecnico di Torino October 2013 Basilio Bona (DAUIN - Politecnico di Torino) Kinematics October 2013 1 / 15 Introduction The kinematic quantities used are: position r,

More information

Lecture Note 12: Dynamics of Open Chains: Lagrangian Formulation

Lecture Note 12: Dynamics of Open Chains: Lagrangian Formulation ECE5463: Introduction to Robotics Lecture Note 12: Dynamics of Open Chains: Lagrangian Formulation Prof. Wei Zhang Department of Electrical and Computer Engineering Ohio State University Columbus, Ohio,

More information

(r i F i ) F i = 0. C O = i=1

(r i F i ) F i = 0. C O = i=1 Notes on Side #3 ThemomentaboutapointObyaforceF that acts at a point P is defined by M O (r P r O F, where r P r O is the vector pointing from point O to point P. If forces F, F, F 3,..., F N act on particles

More information

Rigid bodies - general theory

Rigid bodies - general theory Rigid bodies - general theory Kinetic Energy: based on FW-26 Consider a system on N particles with all their relative separations fixed: it has 3 translational and 3 rotational degrees of freedom. Motion

More information

Nonholonomic Constraints Examples

Nonholonomic Constraints Examples Nonholonomic Constraints Examples Basilio Bona DAUIN Politecnico di Torino July 2009 B. Bona (DAUIN) Examples July 2009 1 / 34 Example 1 Given q T = [ x y ] T check that the constraint φ(q) = (2x + siny

More information

CP1 REVISION LECTURE 3 INTRODUCTION TO CLASSICAL MECHANICS. Prof. N. Harnew University of Oxford TT 2017

CP1 REVISION LECTURE 3 INTRODUCTION TO CLASSICAL MECHANICS. Prof. N. Harnew University of Oxford TT 2017 CP1 REVISION LECTURE 3 INTRODUCTION TO CLASSICAL MECHANICS Prof. N. Harnew University of Oxford TT 2017 1 OUTLINE : CP1 REVISION LECTURE 3 : INTRODUCTION TO CLASSICAL MECHANICS 1. Angular velocity and

More information

(W: 12:05-1:50, 50-N202)

(W: 12:05-1:50, 50-N202) 2016 School of Information Technology and Electrical Engineering at the University of Queensland Schedule of Events Week Date Lecture (W: 12:05-1:50, 50-N202) 1 27-Jul Introduction 2 Representing Position

More information

PLANAR KINETIC EQUATIONS OF MOTION (Section 17.2)

PLANAR KINETIC EQUATIONS OF MOTION (Section 17.2) PLANAR KINETIC EQUATIONS OF MOTION (Section 17.2) We will limit our study of planar kinetics to rigid bodies that are symmetric with respect to a fixed reference plane. As discussed in Chapter 16, when

More information

Kinematics. Basilio Bona. Semester 1, DAUIN Politecnico di Torino. B. Bona (DAUIN) Kinematics Semester 1, / 15

Kinematics. Basilio Bona. Semester 1, DAUIN Politecnico di Torino. B. Bona (DAUIN) Kinematics Semester 1, / 15 Kinematics Basilio Bona DAUIN Politecnico di Torino Semester 1, 2014-15 B. Bona (DAUIN) Kinematics Semester 1, 2014-15 1 / 15 Introduction The kinematic quantities used are: position r, linear velocity

More information

Differential Kinematics

Differential Kinematics Differential Kinematics Relations between motion (velocity) in joint space and motion (linear/angular velocity) in task space (e.g., Cartesian space) Instantaneous velocity mappings can be obtained through

More information

ECEN 420 LINEAR CONTROL SYSTEMS. Lecture 6 Mathematical Representation of Physical Systems II 1/67

ECEN 420 LINEAR CONTROL SYSTEMS. Lecture 6 Mathematical Representation of Physical Systems II 1/67 1/67 ECEN 420 LINEAR CONTROL SYSTEMS Lecture 6 Mathematical Representation of Physical Systems II State Variable Models for Dynamic Systems u 1 u 2 u ṙ. Internal Variables x 1, x 2 x n y 1 y 2. y m Figure

More information

ENGG 5402 Course Project: Simulation of PUMA 560 Manipulator

ENGG 5402 Course Project: Simulation of PUMA 560 Manipulator ENGG 542 Course Project: Simulation of PUMA 56 Manipulator ZHENG Fan, 115551778 mrzhengfan@gmail.com April 5, 215. Preface This project is to derive programs for simulation of inverse dynamics and control

More information

= 0 otherwise. Eu(n) = 0 and Eu(n)u(m) = δ n m

= 0 otherwise. Eu(n) = 0 and Eu(n)u(m) = δ n m A-AE 567 Final Homework Spring 212 You will need Matlab and Simulink. You work must be neat and easy to read. Clearly, identify your answers in a box. You will loose points for poorly written work. You

More information

Lab 3: Quanser Hardware and Proportional Control

Lab 3: Quanser Hardware and Proportional Control Lab 3: Quanser Hardware and Proportional Control The worst wheel of the cart makes the most noise. Benjamin Franklin 1 Objectives The goal of this lab is to: 1. familiarize you with Quanser s QuaRC tools

More information

Robotics I. June 6, 2017

Robotics I. June 6, 2017 Robotics I June 6, 217 Exercise 1 Consider the planar PRPR manipulator in Fig. 1. The joint variables defined therein are those used by the manufacturer and do not correspond necessarily to a Denavit-Hartenberg

More information

Advanced Robotic Manipulation

Advanced Robotic Manipulation Lecture Notes (CS327A) Advanced Robotic Manipulation Oussama Khatib Stanford University Spring 2005 ii c 2005 by Oussama Khatib Contents 1 Spatial Descriptions 1 1.1 Rigid Body Configuration.................

More information

Rigid body dynamics. Basilio Bona. DAUIN - Politecnico di Torino. October 2013

Rigid body dynamics. Basilio Bona. DAUIN - Politecnico di Torino. October 2013 Rigid body dynamics Basilio Bona DAUIN - Politecnico di Torino October 2013 Basilio Bona (DAUIN - Politecnico di Torino) Rigid body dynamics October 2013 1 / 16 Multiple point-mass bodies Each mass is

More information

Example: Inverted pendulum on cart

Example: Inverted pendulum on cart Chapter 25 Eample: Inverted pendulum on cart The figure to the right shows a rigid body attached by an frictionless pin (revolute joint to a cart (modeled as a particle. Thecart slides on a horizontal

More information

Example: Inverted pendulum on cart

Example: Inverted pendulum on cart Chapter 11 Eample: Inverted pendulum on cart The figure to the right shows a rigid body attached by an frictionless pin (revolute) joint to a cart (modeled as a particle). Thecart slides on a horizontal

More information

Linearization problem. The simplest example

Linearization problem. The simplest example Linear Systems Lecture 3 1 problem Consider a non-linear time-invariant system of the form ( ẋ(t f x(t u(t y(t g ( x(t u(t (1 such that x R n u R m y R p and Slide 1 A: f(xu f(xu g(xu and g(xu exist and

More information

Lecture Schedule Week Date Lecture (M: 2:05p-3:50, 50-N202)

Lecture Schedule Week Date Lecture (M: 2:05p-3:50, 50-N202) J = x θ τ = J T F 2018 School of Information Technology and Electrical Engineering at the University of Queensland Lecture Schedule Week Date Lecture (M: 2:05p-3:50, 50-N202) 1 23-Jul Introduction + Representing

More information

Oscillations. Oscillations and Simple Harmonic Motion

Oscillations. Oscillations and Simple Harmonic Motion Oscillations AP Physics C Oscillations and Simple Harmonic Motion 1 Equilibrium and Oscillations A marble that is free to roll inside a spherical bowl has an equilibrium position at the bottom of the bowl

More information

Lab 6a: Pole Placement for the Inverted Pendulum

Lab 6a: Pole Placement for the Inverted Pendulum Lab 6a: Pole Placement for the Inverted Pendulum Idiot. Above her head was the only stable place in the cosmos, the only refuge from the damnation of the Panta Rei, and she guessed it was the Pendulum

More information

Classical Mechanics Comprehensive Exam Solution

Classical Mechanics Comprehensive Exam Solution Classical Mechanics Comprehensive Exam Solution January 31, 011, 1:00 pm 5:pm Solve the following six problems. In the following problems, e x, e y, and e z are unit vectors in the x, y, and z directions,

More information

Classical Mechanics III (8.09) Fall 2014 Assignment 3

Classical Mechanics III (8.09) Fall 2014 Assignment 3 Classical Mechanics III (8.09) Fall 2014 Assignment 3 Massachusetts Institute of Technology Physics Department Due September 29, 2014 September 22, 2014 6:00pm Announcements This week we continue our discussion

More information

Advanced Dynamics. - Lecture 4 Lagrange Equations. Paolo Tiso Spring Semester 2017 ETH Zürich

Advanced Dynamics. - Lecture 4 Lagrange Equations. Paolo Tiso Spring Semester 2017 ETH Zürich Advanced Dynamics - Lecture 4 Lagrange Equations Paolo Tiso Spring Semester 2017 ETH Zürich LECTURE OBJECTIVES 1. Derive the Lagrange equations of a system of particles; 2. Show that the equation of motion

More information

Rotational motion problems

Rotational motion problems Rotational motion problems. (Massive pulley) Masses m and m 2 are connected by a string that runs over a pulley of radius R and moment of inertia I. Find the acceleration of the two masses, as well as

More information

Rotational Kinematics and Dynamics. UCVTS AIT Physics

Rotational Kinematics and Dynamics. UCVTS AIT Physics Rotational Kinematics and Dynamics UCVTS AIT Physics Angular Position Axis of rotation is the center of the disc Choose a fixed reference line Point P is at a fixed distance r from the origin Angular Position,

More information

x(n + 1) = Ax(n) and y(n) = Cx(n) + 2v(n) and C = x(0) = ξ 1 ξ 2 Ex(0)x(0) = I

x(n + 1) = Ax(n) and y(n) = Cx(n) + 2v(n) and C = x(0) = ξ 1 ξ 2 Ex(0)x(0) = I A-AE 567 Final Homework Spring 213 You will need Matlab and Simulink. You work must be neat and easy to read. Clearly, identify your answers in a box. You will loose points for poorly written work. You

More information

Fuzzy Based Robust Controller Design for Robotic Two-Link Manipulator

Fuzzy Based Robust Controller Design for Robotic Two-Link Manipulator Abstract Fuzzy Based Robust Controller Design for Robotic Two-Link Manipulator N. Selvaganesan 1 Prabhu Jude Rajendran 2 S.Renganathan 3 1 Department of Instrumentation Engineering, Madras Institute of

More information

Robot Control Basics CS 685

Robot Control Basics CS 685 Robot Control Basics CS 685 Control basics Use some concepts from control theory to understand and learn how to control robots Control Theory general field studies control and understanding of behavior

More information

Video 8.1 Vijay Kumar. Property of University of Pennsylvania, Vijay Kumar

Video 8.1 Vijay Kumar. Property of University of Pennsylvania, Vijay Kumar Video 8.1 Vijay Kumar 1 Definitions State State equations Equilibrium 2 Stability Stable Unstable Neutrally (Critically) Stable 3 Stability Translate the origin to x e x(t) =0 is stable (Lyapunov stable)

More information

Generalized coordinates and constraints

Generalized coordinates and constraints Generalized coordinates and constraints Basilio Bona DAUIN Politecnico di Torino Semester 1, 2014-15 B. Bona (DAUIN) Generalized coordinates and constraints Semester 1, 2014-15 1 / 25 Coordinates A rigid

More information

Rotational Kinematics

Rotational Kinematics Rotational Kinematics Rotational Coordinates Ridged objects require six numbers to describe their position and orientation: 3 coordinates 3 axes of rotation Rotational Coordinates Use an angle θ to describe

More information

7. FORCE ANALYSIS. Fundamentals F C

7. FORCE ANALYSIS. Fundamentals F C ME 352 ORE NLYSIS 7. ORE NLYSIS his chapter discusses some of the methodologies used to perform force analysis on mechanisms. he chapter begins with a review of some fundamentals of force analysis using

More information

Mechanics Lecture Notes

Mechanics Lecture Notes Mechanics Lecture Notes Lectures 0 and : Motion in a circle. Introduction The important result in this lecture concerns the force required to keep a particle moving on a circular path: if the radius of

More information

UNIT 2 KINEMATICS OF LINKAGE MECHANISMS

UNIT 2 KINEMATICS OF LINKAGE MECHANISMS UNIT 2 KINEMATICS OF LINKAGE MECHANISMS ABSOLUTE AND RELATIVE VELOCITY An absolute velocity is the velocity of a point measured from a fixed point (normally the ground or anything rigidly attached to the

More information

Linköping University Electronic Press

Linköping University Electronic Press Linköping University Electronic Press Report Simulation Model of a 2 Degrees of Freedom Industrial Manipulator Patrik Axelsson Series: LiTH-ISY-R, ISSN 400-3902, No. 3020 ISRN: LiTH-ISY-R-3020 Available

More information

Matlab-Based Tools for Analysis and Control of Inverted Pendula Systems

Matlab-Based Tools for Analysis and Control of Inverted Pendula Systems Matlab-Based Tools for Analysis and Control of Inverted Pendula Systems Slávka Jadlovská, Ján Sarnovský Dept. of Cybernetics and Artificial Intelligence, FEI TU of Košice, Slovak Republic sjadlovska@gmail.com,

More information

DYNAMICS OF SERIAL ROBOTIC MANIPULATORS

DYNAMICS OF SERIAL ROBOTIC MANIPULATORS DYNAMICS OF SERIAL ROBOTIC MANIPULATORS NOMENCLATURE AND BASIC DEFINITION We consider here a mechanical system composed of r rigid bodies and denote: M i 6x6 inertia dyads of the ith body. Wi 6 x 6 angular-velocity

More information

Exponential Controller for Robot Manipulators

Exponential Controller for Robot Manipulators Exponential Controller for Robot Manipulators Fernando Reyes Benemérita Universidad Autónoma de Puebla Grupo de Robótica de la Facultad de Ciencias de la Electrónica Apartado Postal 542, Puebla 7200, México

More information

PHYSICS 110A : CLASSICAL MECHANICS

PHYSICS 110A : CLASSICAL MECHANICS PHYSICS 110A : CLASSICAL MECHANICS 1. Introduction to Dynamics motion of a mechanical system equations of motion : Newton s second law ordinary differential equations (ODEs) dynamical systems simple 2.

More information

Chapter 14. Oscillations. Oscillations Introductory Terminology Simple Harmonic Motion:

Chapter 14. Oscillations. Oscillations Introductory Terminology Simple Harmonic Motion: Chapter 14 Oscillations Oscillations Introductory Terminology Simple Harmonic Motion: Kinematics Energy Examples of Simple Harmonic Oscillators Damped and Forced Oscillations. Resonance. Periodic Motion

More information

Afternoon Section. Physics 1210 Exam 2 November 8, ! v = d! r dt. a avg. = v2. ) T 2! w = m g! f s. = v at v 2 1.

Afternoon Section. Physics 1210 Exam 2 November 8, ! v = d! r dt. a avg. = v2. ) T 2! w = m g! f s. = v at v 2 1. Name Physics 1210 Exam 2 November 8, 2012 Afternoon Section Please write directly on the exam and attach other sheets of work if necessary. Calculators are allowed. No notes or books may be used. Multiple-choice

More information

We are IntechOpen, the world s leading publisher of Open Access books Built by scientists, for scientists. International authors and editors

We are IntechOpen, the world s leading publisher of Open Access books Built by scientists, for scientists. International authors and editors We are IntechOpen, the world s leading publisher of Open Access books Built by scientists, for scientists 3,350 108,000 1.7 M Open access books available International authors and editors Downloads Our

More information

Nonlinear Optimal Trajectory Planning for Free-Floating Space Manipulators using a Gauss Pseudospectral Method

Nonlinear Optimal Trajectory Planning for Free-Floating Space Manipulators using a Gauss Pseudospectral Method SPACE Conferences and Exposition 13-16 September 2016, Long Beach, California AIAA/AAS Astrodynamics Specialist Conference AIAA 2016-5272 Nonlinear Optimal Trajectory Planning for Free-Floating Space Manipulators

More information

Center of Gravity Pearson Education, Inc.

Center of Gravity Pearson Education, Inc. Center of Gravity = The center of gravity position is at a place where the torque from one end of the object is balanced by the torque of the other end and therefore there is NO rotation. Fulcrum Point

More information

16. Rotational Dynamics

16. Rotational Dynamics 6. Rotational Dynamics A Overview In this unit we will address examples that combine both translational and rotational motion. We will find that we will need both Newton s second law and the rotational

More information

Trajectory-tracking control of a planar 3-RRR parallel manipulator

Trajectory-tracking control of a planar 3-RRR parallel manipulator Trajectory-tracking control of a planar 3-RRR parallel manipulator Chaman Nasa and Sandipan Bandyopadhyay Department of Engineering Design Indian Institute of Technology Madras Chennai, India Abstract

More information

Model of a DC Generator Driving a DC Motor (which propels a car)

Model of a DC Generator Driving a DC Motor (which propels a car) Model of a DC Generator Driving a DC Motor (which propels a car) John Hung 5 July 2011 The dc is connected to the dc as illustrated in Fig. 1. Both machines are of permanent magnet type, so their respective

More information

Non-holonomic constraint example A unicycle

Non-holonomic constraint example A unicycle Non-holonomic constraint example A unicycle A unicycle (in gray) moves on a plane; its motion is given by three coordinates: position x, y and orientation θ. The instantaneous velocity v = [ ẋ ẏ ] is along

More information

Rotational & Rigid-Body Mechanics. Lectures 3+4

Rotational & Rigid-Body Mechanics. Lectures 3+4 Rotational & Rigid-Body Mechanics Lectures 3+4 Rotational Motion So far: point objects moving through a trajectory. Next: moving actual dimensional objects and rotating them. 2 Circular Motion - Definitions

More information

CEE 271: Applied Mechanics II, Dynamics Lecture 9: Ch.13, Sec.4-5

CEE 271: Applied Mechanics II, Dynamics Lecture 9: Ch.13, Sec.4-5 1 / 40 CEE 271: Applied Mechanics II, Dynamics Lecture 9: Ch.13, Sec.4-5 Prof. Albert S. Kim Civil and Environmental Engineering, University of Hawaii at Manoa 2 / 40 EQUATIONS OF MOTION:RECTANGULAR COORDINATES

More information

Tentative Physics 1 Standards

Tentative Physics 1 Standards Tentative Physics 1 Standards Mathematics MC1. Arithmetic: I can add, subtract, multiply, and divide real numbers, take their natural and common logarithms, and raise them to real powers and take real

More information

1 Problems 1-3 A disc rotates about an axis through its center according to the relation θ (t) = t 4 /4 2t

1 Problems 1-3 A disc rotates about an axis through its center according to the relation θ (t) = t 4 /4 2t Slide 1 / 30 1 Problems 1-3 disc rotates about an axis through its center according to the relation θ (t) = t 4 /4 2t etermine the angular velocity of the disc at t= 2 s 2 rad/s 4 rad/s 6 rad/s 8 rad/s

More information

Slide 1 / 30. Slide 2 / 30. Slide 3 / m/s -1 m/s

Slide 1 / 30. Slide 2 / 30. Slide 3 / m/s -1 m/s 1 Problems 1-3 disc rotates about an axis through its center according to the relation θ (t) = t 4 /4 2t Slide 1 / 30 etermine the angular velocity of the disc at t= 2 s 2 rad/s 4 rad/s 6 rad/s 8 rad/s

More information

Mechatronic System Case Study: Rotary Inverted Pendulum Dynamic System Investigation

Mechatronic System Case Study: Rotary Inverted Pendulum Dynamic System Investigation Mechatronic System Case Study: Rotary Inverted Pendulum Dynamic System Investigation Dr. Kevin Craig Greenheck Chair in Engineering Design & Professor of Mechanical Engineering Marquette University K.

More information

Lecture 9 Nonlinear Control Design

Lecture 9 Nonlinear Control Design Lecture 9 Nonlinear Control Design Exact-linearization Lyapunov-based design Lab 2 Adaptive control Sliding modes control Literature: [Khalil, ch.s 13, 14.1,14.2] and [Glad-Ljung,ch.17] Course Outline

More information

Lab 5a: Pole Placement for the Inverted Pendulum

Lab 5a: Pole Placement for the Inverted Pendulum Lab 5a: Pole Placement for the Inverted Pendulum November 1, 2011 1 Purpose The objective of this lab is to achieve simultaneous control of both the angular position of the pendulum and horizontal position

More information

CONTROL OF ROBOT CAMERA SYSTEM WITH ACTUATOR S DYNAMICS TO TRACK MOVING OBJECT

CONTROL OF ROBOT CAMERA SYSTEM WITH ACTUATOR S DYNAMICS TO TRACK MOVING OBJECT Journal of Computer Science and Cybernetics, V.31, N.3 (2015), 255 265 DOI: 10.15625/1813-9663/31/3/6127 CONTROL OF ROBOT CAMERA SYSTEM WITH ACTUATOR S DYNAMICS TO TRACK MOVING OBJECT NGUYEN TIEN KIEM

More information

20k rad/s and 2 10k rad/s,

20k rad/s and 2 10k rad/s, ME 35 - Machine Design I Summer Semester 0 Name of Student: Lab Section Number: FINAL EXAM. OPEN BOOK AND CLOSED NOTES. Thursday, August nd, 0 Please show all your work for your solutions on the blank

More information

Robotics I June 11, 2018

Robotics I June 11, 2018 Exercise 1 Robotics I June 11 018 Consider the planar R robot in Fig. 1 having a L-shaped second link. A frame RF e is attached to the gripper mounted on the robot end effector. A B y e C x e Figure 1:

More information

PHYS 1114, Lecture 33, April 10 Contents:

PHYS 1114, Lecture 33, April 10 Contents: PHYS 1114, Lecture 33, April 10 Contents: 1 This class is o cially cancelled, and has been replaced by the common exam Tuesday, April 11, 5:30 PM. A review and Q&A session is scheduled instead during class

More information

Chapter 15 Periodic Motion

Chapter 15 Periodic Motion Chapter 15 Periodic Motion Slide 1-1 Chapter 15 Periodic Motion Concepts Slide 1-2 Section 15.1: Periodic motion and energy Section Goals You will learn to Define the concepts of periodic motion, vibration,

More information

ω avg [between t 1 and t 2 ] = ω(t 1) + ω(t 2 ) 2

ω avg [between t 1 and t 2 ] = ω(t 1) + ω(t 2 ) 2 PHY 302 K. Solutions for problem set #9. Textbook problem 7.10: For linear motion at constant acceleration a, average velocity during some time interval from t 1 to t 2 is the average of the velocities

More information

Dynamic Model of Space Robot Manipulator

Dynamic Model of Space Robot Manipulator Applied Mathematical Sciences, Vol. 9, 215, no. 94, 465-4659 HIKARI Ltd, www.m-hikari.com http://dx.doi.org/1.12988/ams.215.56429 Dynamic Model of Space Robot Manipulator Polina Efimova Saint-Petersburg

More information

Dynamics. 1 Copyright c 2015 Roderic Grupen

Dynamics. 1 Copyright c 2015 Roderic Grupen Dynamics The branch of physics that treats the action of force on bodies in motion or at rest; kinetics, kinematics, and statics, collectively. Websters dictionary Outline Conservation of Momentum Inertia

More information

Phys101 Second Major-173 Zero Version Coordinator: Dr. M. Al-Kuhaili Thursday, August 02, 2018 Page: 1. = 159 kw

Phys101 Second Major-173 Zero Version Coordinator: Dr. M. Al-Kuhaili Thursday, August 02, 2018 Page: 1. = 159 kw Coordinator: Dr. M. Al-Kuhaili Thursday, August 2, 218 Page: 1 Q1. A car, of mass 23 kg, reaches a speed of 29. m/s in 6.1 s starting from rest. What is the average power used by the engine during the

More information

Video 3.1 Vijay Kumar and Ani Hsieh

Video 3.1 Vijay Kumar and Ani Hsieh Video 3.1 Vijay Kumar and Ani Hsieh Robo3x-1.3 1 Dynamics of Robot Arms Vijay Kumar and Ani Hsieh University of Pennsylvania Robo3x-1.3 2 Lagrange s Equation of Motion Lagrangian Kinetic Energy Potential

More information

PLANAR KINETICS OF A RIGID BODY FORCE AND ACCELERATION

PLANAR KINETICS OF A RIGID BODY FORCE AND ACCELERATION PLANAR KINETICS OF A RIGID BODY FORCE AND ACCELERATION I. Moment of Inertia: Since a body has a definite size and shape, an applied nonconcurrent force system may cause the body to both translate and rotate.

More information

z F 3 = = = m 1 F 1 m 2 F 2 m 3 - Linear Momentum dp dt F net = d P net = d p 1 dt d p n dt - Conservation of Linear Momentum Δ P = 0

z F 3 = = = m 1 F 1 m 2 F 2 m 3 - Linear Momentum dp dt F net = d P net = d p 1 dt d p n dt - Conservation of Linear Momentum Δ P = 0 F 1 m 2 F 2 x m 1 O z F 3 m 3 y Ma com = F net F F F net, x net, y net, z = = = Ma Ma Ma com, x com, y com, z p = mv - Linear Momentum F net = dp dt F net = d P dt = d p 1 dt +...+ d p n dt Δ P = 0 - Conservation

More information