7 To solve numerically the equation of motion, we use the velocity Verlet or leap frog algorithm. _ V i n = F i n m i (F.5) For time step, we approxim

Size: px
Start display at page:

Download "7 To solve numerically the equation of motion, we use the velocity Verlet or leap frog algorithm. _ V i n = F i n m i (F.5) For time step, we approxim"

Transcription

1 69 Appendix F Molecular Dynamics F. Introduction In this chapter, we deal with the theories and techniques used in molecular dynamics simulation. The fundamental dynamics equations of any system is the Lagrangian equation of motion d dt ( L )= L _q k q k (F.) where the Lagrangian function L(q; _q) is dened in terms of kinetic and potential energies L = K, V (F.) F. NVE Dynamics For an isolated system, we have Lagrangian as L = X i m i _r i, V (r ;r ;::: ;r i ;:::) (F.3) and dynamics equations r i = F i m i (F.4)

2 7 To solve numerically the equation of motion, we use the velocity Verlet or leap frog algorithm. _ V i n = F i n m i (F.5) For time step, we approximate _ V i n = V i n+, V i n, (F.6) leading to V i n+ = V i n, + F n i m i (F.7) and X n+ = X n + V i n+ (F.8) The problem with these two equations is that the velocities and coordinates are not from the same time step. Thus the KE and PE are available only for dierent time steps. To obtain equations involving V n and X n at the same time step, we start with Eq. (F.7) and estimate V n by V i n = (V i + V i n+ n, ) (F.9) Then we have V i n+ = V i n + F i n m i (F.)

3 7 and V i n = V i n, + F n i m i (F.) F.3 NVT Dynamics F.3. Theory There are many ways of doing molecular dynamics simulations under constant temperature. Among them, the extended system method originally formulated by Nose and Hoover is most important. An additional degree of freedom corresponding to a heat bath is introduced. The total energy of the physical system is allowed to uctuate by a thermal contact with a heat bath. In Nose's original formulation, two frames of variables, real variables corresponding to realistic motion of particles and virtual variables, are introduced. The relations between these two kinds of variables are derived from an assumption of time scaling dt = dt=s, t is a real time, t is a virtual time, and the scaling factor s corresponds to a heat bath variable. The canonical distribution is realized in a physical system if we choose the Lagrangian as the following L = X i m i s r_ i, V (r ;r ;::: ;r i ;:::)+ Q s _s,gk B T B ln s (F.) Equation for particles d dt (m i s _r i )=m i s_s_r i +m i s r i (F.3) Convert the equation to real time by _ A = s da dt (F.4)

4 m i ds dt dr i dt + m is( s 7 d r i dt, s ds dt dr i dt )=Fi (F.5) Dene s = s ds dt (F.6) we have d r i dt = F i, s dri m i dt (F.7) Equation for s d dt (Q s _s) = X i m i s_r i,gk B T B s (F.8) Convert to real time we have Since s Q d X s s dt = s m i _r i, gk B T B s i X i m i s _r i =KE = fk B T (F.9) (F.) where f is the degree of freedom. If we choose g as degree of freedom also, we have d s dt = gk BT B Q s ( T T B, ) (F.)

5 F.3. Numerical Integration 73 Let's consider a general form of dynamics equation with velocity dependent forces, or friction forces V t = F M, fv (F.) where f indicates a frictional term. The numerical equation thus becomes V n+ = V n, + F n M, f nv n (F.3) approximate V n by V n = V n+ + V n, (F.4) Then we have V n+ =, f n + f V n, + n + f n F n M (F.5) It is often convenient to break the leap frog algorithm into two half steps V n,,! V n which is V n+ =(, f n)v n + F n M (F.6) and V n,! V n+

6 74 which is Replacing f by s,wehave V n = + f n V n, + F n + f n M (F.7) V i n+ =(, n)v i n + F i n m i (F.8) V i n = + nv i n, + F n i + n m i (F.9) and n = n, + gk BT B ( T n,, ) (F.3) Q s T B F.4 NPT(Gibbs) Dynamics Formulation F.4. Constant Temperature and Constant Stress Ensemble Constant temperature and constant stress ensemble is one of the most important ensemble being studied, because most of the experiments are done under such condition. Results from molecular dynamics simulation of constant temperature and constant constant stress ensemble can be directly related to experimental results. Andersen 3 has shown how MD calculations can be modied to study systems under constant pressure by introducing the volume of the system as an additional variable. Later on, Parrinello and Rahman 4 extended the variable to simulation cell parameters which results the constant stress ensemble. By combining the Hamiltonian of Nose-Hoover formulation and that of Parrinello-Rahman, we get a constant temperature and constant stress ensemble. Parrinello-Rahman's original formulation used cell transformation matrix H = (a; b; c) which is not invariant under rotation. This

7 75 may introduce articial eects into the dynamics systems, lead to instable systems. In our implementation, we take the metric tensor G = H T H as our variable, which may gaveus better stability. F.4. Coordinates Transformation Let e x ;e y ;e z =fe gbe a set of orthogonal unit vectors and write the primitivevectors for the unit cell as a; b; c = H. Then we can write the coordinates of particle i as R i = H i (F.3) where R i is the coordinate of particle i, i From equation (F.3), we have is the scaled coordinate of particle i. _ R i = H _ i (F.3) The inner product becomes (R i R j )=R i Rj =H H i j = G i j (F.33) where the metric tensor G = H H = H T H =(H T H) (F.34) or G = B H + H + H 3 H H + H 3 H 3 H 3 H 33 H H + H 3 H 3 H + H 3 H 3 H 33 C A (F.35) H 3 H 33 H 3 H 33 H 33

8 76 while H = B p G, H, H 3 (G, H 3 H 3 )=H p G, H 3 C A (F.36) G 3 =H 33 G 3 =H 33 p G33 The H matrix is calculated in the order of H 33! H 3! H 3! H! H! H F.4.3 Strain Tensor Consider a homogeneous distortion H,! H (F.37) in which the unit cell change size but the scaled particle coordinates remain xed. The new particle coordinates are given by R i = H H, ; Ri ; (F.38) Thus the displacement of each particle is given by ~u = ~ R, ~ R =(HH,, )R (F.39) Using the Landau-Lifschitz denition of nite strain = (u x + u x + u x u x ) (F.4) leads then to = ( ~ H, GH,, ) (F.4)

9 77 where the tilde indicates transpose of a matrix and H refers to the reference state of the cell in terms of which the external stress is dened. F.4.4 Lagrangian for Particles and Cell Kinetic Energy For particle kinetic energy, we have KE particle = s X i M i _R i _ R i = s X i M i _ i G _ i (F.4) For nose parameter s KE nose = Q _s (F.43) For cell kinetic energy, we have KE cell = Ws _G _G (F.44) Potential Energy Particles potential energy PE particle includes all valence and nonbond interactions. while the nose potential energy is dened as PE nose = gk B T B log s (F.45) The total potential energy for the stresses system is PE cell = p(, )+ (,S+p) (F.46) where istheunit cell volume, p = T race(s) isthepressure and S is the external 3 stress tensor.

10 78 Dening the transformed stress tensor as = H, (,S+p)~ H, (F.47) we have PE cell = p(, )+ G (F.48) Lagrangian The above results leads to a Lagrangian L = s X i m i _ i G _ i, V (~r ;~r ;::: ;~r i ;:::) + Qs, gk B T B log s + W _G _G s, p(, ), G (F.49) F.4.5 Dynamics Equations Internal Coordinates Since L i = Ri i L R i = H F i (F.5) ( L )= (m t s _ i i s G _ i t )=m i s_sg _ i + m i s G i + m i s _G _ i s (F.5) By using ( L )= L t s _ i i (F.5)

11 79 we have m i s G i = H F i, m i s _sg _ i, m i s _G _ i (F.53) m i s G, G i = G, H F i, m i s _sg, G _ i, m i s G, G _ i i = m i s H, F i, _s s _i, G, G _ i (F.54) (F.55) where we have used G, G = (F.56) G, H = H, (F.57) Convert nose time to real time _A = A t s = s A t (F.58) then s t ( s i t )= i s t, s s 3 t i t (F.59) Dene s = s s t P = G, G t (F.6) (F.6) Finally we have i t = H, F i m i, si t, P i t (F.6)

12 Nose Parameter 8 L s L _s = X i m i s i G i, gk B T B s + Ws _ G _G (F.63) = Q _s (F.64) s = s t ( s Put them together, and we have t t )= s s t (F.65) Q s t = X i m i s i G i, gk B T B + Ws _G _G =(KE particles + KE cell ), gk B T B = gk B (T, T B ) (F.66) where we have used KE particles + KE cell = gk B T with T as the system temperature. Dening Q = gk B T B s (F.67) we have s t = ( T, ) (F.68) s T B

13 8 Metric G Since, V = P pe V = V G G (F.69) (F.7) = H G ~ G, H, G = ~ H, [ ( + )]H, = 4 ( ~ H, H, + ~ H, H, ) (F.7) So V =, G 4 ( H ~, H, + ~ H, H, pe )P =, H, P pe ~ H, (F.7) where we have used the symmetry property of P pe. Similarly KE particle G = H, P ke ~ H, (F.73) Since det H = ijk H i H j H k (F.74) det H H i = ijk H j H k (F.75) H i det H H i = ijk H i H j H k = det H (F.76)

14 8 det H H = ~ H, det H (F.77) = ~a ( ~ b ~c) = ijk H i H j H k3 = det H (F.78) det G = det ~ H det H = (det H) = (F.79) = G G ~, = G, (F.8) By using the above equations, we have L G = H, (P pe + P ke ) ~ H, P ext G,, = H (P, internal, S external ) H ~, P ext G, (F.8) L _G = Ws _G (F.8) G = h i H, W (P internal, S external ) H ~, P ext G,, s _s _G (F.83) In Hoover formulation (real time) G t = h i H, W (P internal, S external ) H ~, P ext G,, s _G (F.84)

15 F.4.6 About Cell Mass 83 From the above derivation, W _G has unit of ML. We propose T has unit of WL4 T while the kinetic energy usually W = fm cell, 3 (F.85) with f a scale factor and M cell = nx i m i (F.86) F.4.7 Numeric Integration Two Step Leap-frog for TPN Following are the equations used in our integration i t = H, F i m i, si t, P i t (F.87) G t = h i H, W (P internal, S external ) H ~,, P ext G,, s _G (F.88) and The n,,! n, s t = ( T, ) (F.89) s T B equation for internal velocites of particles V n, =[, (P + s )]V n, + F atm n, M (F.9)

16 The n,,! n, 84 equation for velocity of metric parameters _G n, =(, s ) _G n, + F cell n, W (F.9) Nose parameter Internal coordinates of particles s n = s n, + ( T n,, ) (F.9) s T B X n = X n, + V n, (F.93) Metric parameters G n = G n, + _G n, (F.94) The n,,! n equation for internal velocity of particles V n = + (P n + s n) V n, + + (P n +n) s F atm n M (F.95) The n,,! n equation for velocity of metric parameters _G n = + s n _G n, + + s n F cell n W (F.96) since P n and F cell n depends on V n and _G n, we have to solve these two equations self-consistently. Following is the owchart of an integration circle.

17 85 Figure F.: NPT dynamics owchart

18 F.5 Rigid Dynamics 86 In general, atomistic molecular dynamics of various ensemble can handle most of the molecular systems; however treating some of the molecules as rigid can decrease the degree of freedoms and increase dynamics time-step, and thus, can simulate larger systems longer. F.5. Partition of dynamics equations Consider the motions of a rigid molecule M interacting with other atoms or molecules. For a nonlinear molecule there are 6 degrees of freedom (3 translation, 3 rotation). The forces on the atoms of M are calculated and combined to obtain the net forces and torques on the body F M =, X im V r i (F.97) T M =, X im (r i, R cm ) V r i (F.98) These calculations are carried out in normal space-xed coordinates. We introduce a coordinate system attached to the center of mass with the same orientation as the space-xed system at the initial time. The particle position r(t) i =R cm (t)+a (t)[r() i, R cm ()] (F.99) where A (t) is the rotation matrix. The particle velocities are then given by v(t) i =V cm (t)+! (t)[r(t) i, R cm (t)] (F.) where! is the angular velocity

19 87 Dene r i cm(t) =r i (t),r cm (t) (F.) Using equation (F.) in KE, we have KE = X im m i v i v i = MV cm V cm + X im i m i h!(t) rcm(t) i = KE cm + KE rot (F.) So we can partition equation of motion into center of mass translation and rotation with respect to center of mass coordinates. It's the angular motion which needs further study. F.5. Dynamics Equation for Angular Motion We can write the rotational kinetic energy as KE rot = X im m i! r i cm;! r i cm; (F.3) By using =, (F.4) we have KE rot = = X im X im m i [!! r i cm; ri cm;,!! r i cm; ri cm;] m i! ( r i cm, r i cm; ri cm;)! = I!! (F.5)

20 88 where I = X im m i ( r i cm, r i cm; ri cm;) (F.6) is dened as the moment of inertia tensor. The angular momentum We can rewrite KE rot as J = KE rot! = I! (F.7) KE rot = I, J J (F.8) Then for micro-canonical ensemble L = L NV E + X M M cm V i cm V i cm + and for canonical ensemble we have Lagrangian as L = L NV T + X M M cm s V i cm V i cm + and for Gibbs ensemble we have Lagrangian as L = L NPT + X M M cm s V i cm V i cm + X M X M X M I M!M!M s I M!M!M s I M!M!M (F.9) (F.) (F.) noted, there are no coupling between cell deformation and rotation of rigid molecules. For rotational degree of freedom, the dynamics equation takes the form of _ J = T, fj (F.) where T =, V, f = s for canonical and Gibbs ensembles, f = for micro-

21 canonical ensemble. 89 The two-step numerical integration equations are: J n, =(, f n,)j n, + T n, (F.3) and J n = + f n, J n, + + f n, T n (F.4) The above equation is in space-xed coordinates. In order to solve for the new angular coordinates, we must transform from space-xed (J) to body-xed (J B ) coordinates by applying J B = A (t)j (F.5) where A (t) takes the current space-xed coordinates transform back to the body- xed coordinates at t =. Since J = I! (F.6) where I is evaluated in the original body-xed coordinate system at t =. Thus! B (t) =I, J B (t)=i, A(t)J (F.7) F.5.3 Solving the Equation Using Quaternions Since the potential energy and forces (thus torques) are evaluated in space-xed coordinate systems, while the moment ofinternia is most easily expressed in a body- xed coordinate system, we have to relating the coordinates of a moving-body to a space xed coordinate system. The most common approach is in terms of Euler angles:; ;, where and give the orientation of a body axis relative to the space-

22 9 z ζ η y z x φ ξ z ζ θ η ζ θ η x φ ξ y x φ ψ ξ y Figure F.: The rotations dening the Euler angles xed frame and is the rotation of the body about this axis. The transformation tensor is A = B cos cos, cos sin sin cos sin + cos cos sin sin sin, sin cos, cos sin cos, sin sin + cos cos cos cos sin sin sin, sin cos cos (F.8) C A However, Euler angles lead to singularities whenever the equation of motion takes too close to o or 8 o. The using of four variable quaternions rather than the three variable Euler angles can by-pass the singularity problems.

23 9 The quaternions are dened in terms of Euler angles as Q x = sin cos, (F.9) Q y = sin sin, (F.) Q z = cos sin + (F.) where the normalization condition is Q 4 = cos cos + 4X = Q = (F.) (F.3) The relation between A and Q is A ii = Q 4 + Q i, X j6=i Q j (F.4) A ij =Q i Q j + ijk Q 4 Q k if i 6= j (F.5) where i =;;3. In matrix form A = B Q x, Q y, Q z + Q 4 Q x Q y +Q 4 Q z Q x Q z,q 4 Q y Q x Q y,q 4 Q z,q x+q y,q z+q 4 Q y Q z +Q 4 Q x Q x Q z +Q 4 Q y Q y Q z,q 4 Q x,q x,q y+q z+q 4 C A (F.6)

24 9 the quaternions change smoothly in time with no singualr points. The relation between _Q and! is _Q i = (Q 4! i + ijk Q j! k ), i =;;3 (F.7) _Q 4 =, Q i! i (F.8) If we dene! 4 =,in matrix form _Q = S! (F.9) we have S = B Q 4,Q z Q y Q x Q z Q 4,Q x Q y,q y Q x Q 4 Q z C A (F.3),Q x,q y,q z Q 4 Note that ~ SS= Let's partition the equation Q n = Q n, + _ Q n, (F.3) into Q n, = Q n, + _ Q n, (F.3) Q n = Q n, + _Q n, (F.33) Then following is the owchart of one dynamics step

25 93 Figure F.3: Rigid dynamics owchart

26 F.5.4 Linear Molecule 94 Figure F.4: Orientation of linear molecule Let's assume the bond axis of a linear molecule as ~r as in the above gure; we can diagnolize the inertia tensor by transformation coordinate system (x; y; z) into (x ;y ;z ) I =AIA T = B a a C A (F.34) Since the inverse is singular, we haveto pay special attention to linear molecule. We require angular momentum J be orthogonal to the bond axis. Denoting the unit vector along the molecule as e a, we must have J e a = (F.35)

27 95 Then rewrite I as proportional to the unit matrix I = B C a a A = a a (F.36) The kinetic energy becomes KE rot = J J I (F.37) To ensure angular momentum J be orthogonal to linear molecule bond axis, we Schmit orthogonalize each iteration by applying J new = J old, (e a J old )e a (F.38) The inverse of inertia tensor I, can be calculated as I, = A B T racei T racei T racei C A ~ A (F.39) where transformation matrix A can be calculated with Euler angle (; ; ) as = arccos r z r r y =, arccos p r x + ry = (F.4) The quantities specied are dened in Fig. F.4

28 F.6 References 96. S. Nose, J. Chem. Phys. 8, 984, 5.. W.H. Hoover, Phys. Rev. A 3, 985, H.C. Andersen, J. Chem. Phys. 7, 98, M. Parrinello and A. Rahman, Phys. Rev. Lett. 45(4), 98,

Temperature and Pressure Controls

Temperature and Pressure Controls Ensembles Temperature and Pressure Controls 1. (E, V, N) microcanonical (constant energy) 2. (T, V, N) canonical, constant volume 3. (T, P N) constant pressure 4. (T, V, µ) grand canonical #2, 3 or 4 are

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

CE 530 Molecular Simulation

CE 530 Molecular Simulation CE 530 Molecular Simulation Lecture 7 Beyond Atoms: Simulating Molecules David A. Kofke Department of Chemical Engineering SUNY Buffalo kofke@eng.buffalo.edu Review Fundamentals units, properties, statistical

More information

Introduction Statistical Thermodynamics. Monday, January 6, 14

Introduction Statistical Thermodynamics. Monday, January 6, 14 Introduction Statistical Thermodynamics 1 Molecular Simulations Molecular dynamics: solve equations of motion Monte Carlo: importance sampling r 1 r 2 r n MD MC r 1 r 2 2 r n 2 3 3 4 4 Questions How can

More information

What is Classical Molecular Dynamics?

What is Classical Molecular Dynamics? What is Classical Molecular Dynamics? Simulation of explicit particles (atoms, ions,... ) Particles interact via relatively simple analytical potential functions Newton s equations of motion are integrated

More information

MD Thermodynamics. Lecture 12 3/26/18. Harvard SEAS AP 275 Atomistic Modeling of Materials Boris Kozinsky

MD Thermodynamics. Lecture 12 3/26/18. Harvard SEAS AP 275 Atomistic Modeling of Materials Boris Kozinsky MD Thermodynamics Lecture 1 3/6/18 1 Molecular dynamics The force depends on positions only (not velocities) Total energy is conserved (micro canonical evolution) Newton s equations of motion (second order

More information

arxiv: v1 [math.ds] 18 Nov 2008

arxiv: v1 [math.ds] 18 Nov 2008 arxiv:0811.2889v1 [math.ds] 18 Nov 2008 Abstract Quaternions And Dynamics Basile Graf basile.graf@epfl.ch February, 2007 We give a simple and self contained introduction to quaternions and their practical

More information

Work - kinetic energy theorem for rotational motion *

Work - kinetic energy theorem for rotational motion * OpenStax-CNX module: m14307 1 Work - kinetic energy theorem for rotational motion * Sunil Kumar Singh This work is produced by OpenStax-CNX and licensed under the Creative Commons Attribution License 2.0

More information

Chapter 10. Rotation of a Rigid Object about a Fixed Axis

Chapter 10. Rotation of a Rigid Object about a Fixed Axis Chapter 10 Rotation of a Rigid Object about a Fixed Axis 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. A small

More information

A Nobel Prize for Molecular Dynamics and QM/MM What is Classical Molecular Dynamics? Simulation of explicit particles (atoms, ions,... ) Particles interact via relatively simple analytical potential

More information

Rotational Motion. Chapter 4. P. J. Grandinetti. Sep. 1, Chem P. J. Grandinetti (Chem. 4300) Rotational Motion Sep.

Rotational Motion. Chapter 4. P. J. Grandinetti. Sep. 1, Chem P. J. Grandinetti (Chem. 4300) Rotational Motion Sep. Rotational Motion Chapter 4 P. J. Grandinetti Chem. 4300 Sep. 1, 2017 P. J. Grandinetti (Chem. 4300) Rotational Motion Sep. 1, 2017 1 / 76 Angular Momentum The angular momentum of a particle with respect

More information

Physics A - PHY 2048C

Physics A - PHY 2048C Physics A - PHY 2048C and 11/15/2017 My Office Hours: Thursday 2:00-3:00 PM 212 Keen Building Warm-up Questions 1 Did you read Chapter 12 in the textbook on? 2 Must an object be rotating to have a moment

More information

Physical Dynamics (PHY-304)

Physical Dynamics (PHY-304) Physical Dynamics (PHY-304) Gabriele Travaglini March 31, 2012 1 Review of Newtonian Mechanics 1.1 One particle Lectures 1-2. Frame, velocity, acceleration, number of degrees of freedom, generalised coordinates.

More information

Temperature and Pressure Controls

Temperature and Pressure Controls Ensembles Temperature and Pressure Controls 1. (E, V, N) microcanonical (constant energy) 2. (T, V, N) canonical, constant volume 3. (T, P N) constant pressure 4. (T, V, µ) grand canonical #2, 3 or 4 are

More information

Molecular Dynamics Simulations. Dr. Noelia Faginas Lago Dipartimento di Chimica,Biologia e Biotecnologie Università di Perugia

Molecular Dynamics Simulations. Dr. Noelia Faginas Lago Dipartimento di Chimica,Biologia e Biotecnologie Università di Perugia Molecular Dynamics Simulations Dr. Noelia Faginas Lago Dipartimento di Chimica,Biologia e Biotecnologie Università di Perugia 1 An Introduction to Molecular Dynamics Simulations Macroscopic properties

More information

Lesson Rigid Body Dynamics

Lesson Rigid Body Dynamics Lesson 8 Rigid Body Dynamics Lesson 8 Outline Problem definition and motivations Dynamics of rigid bodies The equation of unconstrained motion (ODE) User and time control Demos / tools / libs Rigid Body

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

Molecular Dynamics Simulation Study of Transport Properties of Diatomic Gases

Molecular Dynamics Simulation Study of Transport Properties of Diatomic Gases MD Simulation of Diatomic Gases Bull. Korean Chem. Soc. 14, Vol. 35, No. 1 357 http://dx.doi.org/1.51/bkcs.14.35.1.357 Molecular Dynamics Simulation Study of Transport Properties of Diatomic Gases Song

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

Energy and Forces in DFT

Energy and Forces in DFT Energy and Forces in DFT Total Energy as a function of nuclear positions {R} E tot ({R}) = E DF T ({R}) + E II ({R}) (1) where E DF T ({R}) = DFT energy calculated for the ground-state density charge-density

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

PHYS 705: Classical Mechanics. Introduction and Derivative of Moment of Inertia Tensor

PHYS 705: Classical Mechanics. Introduction and Derivative of Moment of Inertia Tensor 1 PHYS 705: Classical Mechanics Introduction and Derivative of Moment of Inertia Tensor L and N depends on the Choice of Origin Consider a particle moving in a circle with constant v. If we pick the origin

More information

. D CR Nomenclature D 1

. D CR Nomenclature D 1 . D CR Nomenclature D 1 Appendix D: CR NOMENCLATURE D 2 The notation used by different investigators working in CR formulations has not coalesced, since the topic is in flux. This Appendix identifies the

More information

Massachusetts Institute of Technology Department of Physics. Final Examination December 17, 2004

Massachusetts Institute of Technology Department of Physics. Final Examination December 17, 2004 Massachusetts Institute of Technology Department of Physics Course: 8.09 Classical Mechanics Term: Fall 004 Final Examination December 17, 004 Instructions Do not start until you are told to do so. Solve

More information

COMPLETE ALL ROUGH WORKINGS IN THE ANSWER BOOK AND CROSS THROUGH ANY WORK WHICH IS NOT TO BE ASSESSED.

COMPLETE ALL ROUGH WORKINGS IN THE ANSWER BOOK AND CROSS THROUGH ANY WORK WHICH IS NOT TO BE ASSESSED. BSc/MSci EXAMINATION PHY-304 Time Allowed: Physical Dynamics 2 hours 30 minutes Date: 28 th May 2009 Time: 10:00 Instructions: Answer ALL questions in section A. Answer ONLY TWO questions from section

More information

Rotation. Kinematics Rigid Bodies Kinetic Energy. Torque Rolling. featuring moments of Inertia

Rotation. Kinematics Rigid Bodies Kinetic Energy. Torque Rolling. featuring moments of Inertia Rotation Kinematics Rigid Bodies Kinetic Energy featuring moments of Inertia Torque Rolling Angular Motion We think about rotation in the same basic way we do about linear motion How far does it go? How

More information

PHY 5246: Theoretical Dynamics, Fall Assignment # 10, Solutions. (1.a) N = a. we see that a m ar a = 0 and so N = 0. ω 3 ω 2 = 0 ω 2 + I 1 I 3

PHY 5246: Theoretical Dynamics, Fall Assignment # 10, Solutions. (1.a) N = a. we see that a m ar a = 0 and so N = 0. ω 3 ω 2 = 0 ω 2 + I 1 I 3 PHY 54: Theoretical Dynamics, Fall 015 Assignment # 10, Solutions 1 Graded Problems Problem 1 x 3 a ω First we calculate the moments of inertia: ( ) a I 1 = I = m 4 + b, 1 (1.a) I 3 = ma. b/ α The torque

More information

PHYS 705: Classical Mechanics. Euler s Equations

PHYS 705: Classical Mechanics. Euler s Equations 1 PHYS 705: Classical Mechanics Euler s Equations 2 Euler s Equations (set up) We have seen how to describe the kinematic properties of a rigid body. Now, we would like to get equations of motion for it.

More information

MATHEMATICAL PHYSICS

MATHEMATICAL PHYSICS MATHEMATICAL PHYSICS Third Year SEMESTER 1 015 016 Classical Mechanics MP350 Prof. S. J. Hands, Prof. D. M. Heffernan, Dr. J.-I. Skullerud and Dr. M. Fremling Time allowed: 1 1 hours Answer two questions

More information

Aspects of nonautonomous molecular dynamics

Aspects of nonautonomous molecular dynamics Aspects of nonautonomous molecular dynamics IMA, University of Minnesota, Minneapolis January 28, 2007 Michel Cuendet Swiss Institute of Bioinformatics, Lausanne, Switzerland Introduction to the Jarzynski

More information

Physics 106a, Caltech 4 December, Lecture 18: Examples on Rigid Body Dynamics. Rotating rectangle. Heavy symmetric top

Physics 106a, Caltech 4 December, Lecture 18: Examples on Rigid Body Dynamics. Rotating rectangle. Heavy symmetric top Physics 106a, Caltech 4 December, 2018 Lecture 18: Examples on Rigid Body Dynamics I go through a number of examples illustrating the methods of solving rigid body dynamics. In most cases, the problem

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

Phys 7221 Homework # 8

Phys 7221 Homework # 8 Phys 71 Homework # 8 Gabriela González November 15, 6 Derivation 5-6: Torque free symmetric top In a torque free, symmetric top, with I x = I y = I, the angular velocity vector ω in body coordinates with

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

Torque and Rotation Lecture 7

Torque and Rotation Lecture 7 Torque and Rotation Lecture 7 ˆ In this lecture we finally move beyond a simple particle in our mechanical analysis of motion. ˆ Now we consider the so-called rigid body. Essentially, a particle with extension

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

Translational vs Rotational. m x. Connection Δ = = = = = = Δ = = = = = = Δ =Δ = = = = = 2 / 1/2. Work

Translational vs Rotational. m x. Connection Δ = = = = = = Δ = = = = = = Δ =Δ = = = = = 2 / 1/2. Work Translational vs Rotational / / 1/ Δ m x v dx dt a dv dt F ma p mv KE mv Work Fd / / 1/ θ ω θ α ω τ α ω ω τθ Δ I d dt d dt I L I KE I Work / θ ω α τ Δ Δ c t s r v r a v r a r Fr L pr Connection Translational

More information

Gear methods I + 1/18

Gear methods I + 1/18 Gear methods I + 1/18 Predictor-corrector type: knowledge of history is used to predict an approximate solution, which is made more accurate in the following step we do not want (otherwise good) methods

More information

Ab initio molecular dynamics. Simone Piccinin CNR-IOM DEMOCRITOS Trieste, Italy. Bangalore, 04 September 2014

Ab initio molecular dynamics. Simone Piccinin CNR-IOM DEMOCRITOS Trieste, Italy. Bangalore, 04 September 2014 Ab initio molecular dynamics Simone Piccinin CNR-IOM DEMOCRITOS Trieste, Italy Bangalore, 04 September 2014 What is MD? 1) Liquid 4) Dye/TiO2/electrolyte 2) Liquids 3) Solvated protein 5) Solid to liquid

More information

Physics 235 Chapter 7. Chapter 7 Hamilton's Principle - Lagrangian and Hamiltonian Dynamics

Physics 235 Chapter 7. Chapter 7 Hamilton's Principle - Lagrangian and Hamiltonian Dynamics Chapter 7 Hamilton's Principle - Lagrangian and Hamiltonian Dynamics Many interesting physics systems describe systems of particles on which many forces are acting. Some of these forces are immediately

More information

Ab initio Molecular Dynamics Born Oppenheimer and beyond

Ab initio Molecular Dynamics Born Oppenheimer and beyond Ab initio Molecular Dynamics Born Oppenheimer and beyond Reminder, reliability of MD MD trajectories are chaotic (exponential divergence with respect to initial conditions), BUT... With a good integrator

More information

Physics 607 Final Exam

Physics 607 Final Exam Physics 607 Final Exam Please be well-organized, and show all significant steps clearly in all problems. You are graded on your work, so please do not just write down answers with no explanation! Do all

More information

Handout 6: Rotational motion and moment of inertia. Angular velocity and angular acceleration

Handout 6: Rotational motion and moment of inertia. Angular velocity and angular acceleration 1 Handout 6: Rotational motion and moment of inertia Angular velocity and angular acceleration In Figure 1, a particle b is rotating about an axis along a circular path with radius r. The radius sweeps

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

Chapter 3. Forces, Momentum & Stress. 3.1 Newtonian mechanics: a very brief résumé

Chapter 3. Forces, Momentum & Stress. 3.1 Newtonian mechanics: a very brief résumé Chapter 3 Forces, Momentum & Stress 3.1 Newtonian mechanics: a very brief résumé In classical Newtonian particle mechanics, particles (lumps of matter) only experience acceleration when acted on by external

More information

Video 2.1a Vijay Kumar and Ani Hsieh

Video 2.1a Vijay Kumar and Ani Hsieh Video 2.1a Vijay Kumar and Ani Hsieh Robo3x-1.3 1 Introduction to Lagrangian Mechanics Vijay Kumar and Ani Hsieh University of Pennsylvania Robo3x-1.3 2 Analytical Mechanics Aristotle Galileo Bernoulli

More information

Angular Momentum Conservation of Angular Momentum

Angular Momentum Conservation of Angular Momentum Lecture 22 Chapter 12 Physics I Angular Momentum Conservation of Angular Momentum Course website: http://faculty.uml.edu/andriy_danylov/teaching/physicsi IN THIS CHAPTER, you will continue discussing rotational

More information

REVIEW. Hamilton s principle. based on FW-18. Variational statement of mechanics: (for conservative forces) action Equivalent to Newton s laws!

REVIEW. Hamilton s principle. based on FW-18. Variational statement of mechanics: (for conservative forces) action Equivalent to Newton s laws! Hamilton s principle Variational statement of mechanics: (for conservative forces) action Equivalent to Newton s laws! based on FW-18 REVIEW the particle takes the path that minimizes the integrated difference

More information

3 2 6 Solve the initial value problem u ( t) 3. a- If A has eigenvalues λ =, λ = 1 and corresponding eigenvectors 1

3 2 6 Solve the initial value problem u ( t) 3. a- If A has eigenvalues λ =, λ = 1 and corresponding eigenvectors 1 Math Problem a- If A has eigenvalues λ =, λ = 1 and corresponding eigenvectors 1 3 6 Solve the initial value problem u ( t) = Au( t) with u (0) =. 3 1 u 1 =, u 1 3 = b- True or false and why 1. if A is

More information

[ ] ( ) L = L = r p. We can deal with this more conveniently by writing: so that L becomes: α α α. α α N N N N

[ ] ( ) L = L = r p. We can deal with this more conveniently by writing: so that L becomes: α α α. α α N N N N Lecture 5: Angular Momentum and Energy of a System The total angular momentum is given by the sum of the angular momenta of all particles in the system: We can deal with this more conveniently by writing:

More information

M2A2 Problem Sheet 3 - Hamiltonian Mechanics

M2A2 Problem Sheet 3 - Hamiltonian Mechanics MA Problem Sheet 3 - Hamiltonian Mechanics. The particle in a cone. A particle slides under gravity, inside a smooth circular cone with a vertical axis, z = k x + y. Write down its Lagrangian in a) Cartesian,

More information

Lecture 41: Highlights

Lecture 41: Highlights Lecture 41: Highlights The goal of this lecture is to remind you of some of the key points that we ve covered this semester Note that this is not the complete set of topics that may appear on the final

More information

Noether s Theorem. 4.1 Ignorable Coordinates

Noether s Theorem. 4.1 Ignorable Coordinates 4 Noether s Theorem 4.1 Ignorable Coordinates A central recurring theme in mathematical physics is the connection between symmetries and conservation laws, in particular the connection between the symmetries

More information

Variation Principle in Mechanics

Variation Principle in Mechanics Section 2 Variation Principle in Mechanics Hamilton s Principle: Every mechanical system is characterized by a Lagrangian, L(q i, q i, t) or L(q, q, t) in brief, and the motion of he system is such that

More information

12. Rigid Body Dynamics I

12. Rigid Body Dynamics I University of Rhode Island DigitalCommons@URI Classical Dynamics Physics Course Materials 015 1. Rigid Body Dynamics I Gerhard Müller University of Rhode Island, gmuller@uri.edu Creative Commons License

More information

General Definition of Torque, final. Lever Arm. General Definition of Torque 7/29/2010. Units of Chapter 10

General Definition of Torque, final. Lever Arm. General Definition of Torque 7/29/2010. Units of Chapter 10 Units of Chapter 10 Determining Moments of Inertia Rotational Kinetic Energy Rotational Plus Translational Motion; Rolling Why Does a Rolling Sphere Slow Down? General Definition of Torque, final Taking

More information

Entanglement in Topological Phases

Entanglement in Topological Phases Entanglement in Topological Phases Dylan Liu August 31, 2012 Abstract In this report, the research conducted on entanglement in topological phases is detailed and summarized. This includes background developed

More information

*School of Aeronautics and Astronautics, Purdue University, West Lafayette, IN

*School of Aeronautics and Astronautics, Purdue University, West Lafayette, IN NEW CONTROL LAWS FOR THE ATTITUDE STABILIZATION OF RIGID BODIES PANAGIOTIS TSIOTRAS *School of Aeronautics and Astronautics, Purdue University, West Lafayette, IN 7907. Abstract. This paper introduces

More information

DIFFERENTIAL KINEMATICS. Geometric Jacobian. Analytical Jacobian. Kinematic singularities. Kinematic redundancy. Inverse differential kinematics

DIFFERENTIAL KINEMATICS. Geometric Jacobian. Analytical Jacobian. Kinematic singularities. Kinematic redundancy. Inverse differential kinematics DIFFERENTIAL KINEMATICS relationship between joint velocities and end-effector velocities Geometric Jacobian Analytical Jacobian Kinematic singularities Kinematic redundancy Inverse differential kinematics

More information

Lecture 9: Eigenvalues and Eigenvectors in Classical Mechanics (See Section 3.12 in Boas)

Lecture 9: Eigenvalues and Eigenvectors in Classical Mechanics (See Section 3.12 in Boas) Lecture 9: Eigenvalues and Eigenvectors in Classical Mechanics (See Section 3 in Boas) As suggested in Lecture 8 the formalism of eigenvalues/eigenvectors has many applications in physics, especially in

More information

where (E) is the partition function of the uniform ensemble. Recalling that we have (E) = E (E) (E) i = ij x (E) j E = ij ln (E) E = k ij ~ S E = kt i

where (E) is the partition function of the uniform ensemble. Recalling that we have (E) = E (E) (E) i = ij x (E) j E = ij ln (E) E = k ij ~ S E = kt i G25.265: Statistical Mechanics Notes for Lecture 4 I. THE CLASSICAL VIRIAL THEOREM (MICROCANONICAL DERIVATION) Consider a system with Hamiltonian H(x). Let x i and x j be specic components of the phase

More information

1. Electricity and Magnetism (Fall 1995, Part 1) A metal sphere has a radius R and a charge Q.

1. Electricity and Magnetism (Fall 1995, Part 1) A metal sphere has a radius R and a charge Q. 1. Electricity and Magnetism (Fall 1995, Part 1) A metal sphere has a radius R and a charge Q. (a) Compute the electric part of the Maxwell stress tensor T ij (r) = 1 {E i E j 12 } 4π E2 δ ij both inside

More information

Contents. Dynamics and control of mechanical systems. Focus on

Contents. Dynamics and control of mechanical systems. Focus on Dynamics and control of mechanical systems Date Day 1 (01/08) Day 2 (03/08) Day 3 (05/08) Day 4 (07/08) Day 5 (09/08) Day 6 (11/08) Content Review of the basics of mechanics. Kinematics of rigid bodies

More information

Lecture 38: Equations of Rigid-Body Motion

Lecture 38: Equations of Rigid-Body Motion Lecture 38: Equations of Rigid-Body Motion It s going to be easiest to find the equations of motion for the object in the body frame i.e., the frame where the axes are principal axes In general, we can

More information

N mg N Mg N Figure : Forces acting on particle m and inclined plane M. (b) The equations of motion are obtained by applying the momentum principles to

N mg N Mg N Figure : Forces acting on particle m and inclined plane M. (b) The equations of motion are obtained by applying the momentum principles to .004 MDEING DNMIS ND NTR I I Spring 00 Solutions for Problem Set 5 Problem. Particle slides down movable inclined plane. The inclined plane of mass M is constrained to move parallel to the -axis, and the

More information

Dynamics. Dynamics of mechanical particle and particle systems (many body systems)

Dynamics. Dynamics of mechanical particle and particle systems (many body systems) Dynamics Dynamics of mechanical particle and particle systems (many body systems) Newton`s first law: If no net force acts on a body, it will move on a straight line at constant velocity or will stay at

More information

Understanding Molecular Simulation 2009 Monte Carlo and Molecular Dynamics in different ensembles. Srikanth Sastry

Understanding Molecular Simulation 2009 Monte Carlo and Molecular Dynamics in different ensembles. Srikanth Sastry JNCASR August 20, 21 2009 Understanding Molecular Simulation 2009 Monte Carlo and Molecular Dynamics in different ensembles Srikanth Sastry Jawaharlal Nehru Centre for Advanced Scientific Research, Bangalore

More information

DEVIL PHYSICS BADDEST CLASS ON CAMPUS IB PHYSICS

DEVIL PHYSICS BADDEST CLASS ON CAMPUS IB PHYSICS DEVIL PHYSICS BADDEST CLASS ON CAMPUS IB PHYSICS OPTION B-1A: ROTATIONAL DYNAMICS Essential Idea: The basic laws of mechanics have an extension when equivalent principles are applied to rotation. Actual

More information

Manipulator Dynamics 2. Instructor: Jacob Rosen Advanced Robotic - MAE 263D - Department of Mechanical & Aerospace Engineering - UCLA

Manipulator Dynamics 2. Instructor: Jacob Rosen Advanced Robotic - MAE 263D - Department of Mechanical & Aerospace Engineering - UCLA Manipulator Dynamics 2 Forward Dynamics Problem Given: Joint torques and links geometry, mass, inertia, friction Compute: Angular acceleration of the links (solve differential equations) Solution Dynamic

More information

The... of a particle is defined as its change in position in some time interval.

The... of a particle is defined as its change in position in some time interval. Distance is the. of a path followed by a particle. Distance is a quantity. The... of a particle is defined as its change in position in some time interval. Displacement is a.. quantity. The... of a particle

More information

31st Jerusalem Winter School in Theoretical Physics: Problem Set 2

31st Jerusalem Winter School in Theoretical Physics: Problem Set 2 31st Jerusalem Winter School in Theoretical Physics: Problem Set Contents Frank Verstraete: Quantum Information and Quantum Matter : 3 : Solution to Problem 9 7 Daniel Harlow: Black Holes and Quantum Information

More information

CS-184: Computer Graphics

CS-184: Computer Graphics CS-184: Computer Graphics Lecture #25: Rigid Body Simulations Tobias Pfaff 537 Soda (Visual Computing Lab) tpfaff@berkeley.edu Reminder Final project presentations next week! Game Physics Types of Materials

More information

V (r,t) = i ˆ u( x, y,z,t) + ˆ j v( x, y,z,t) + k ˆ w( x, y, z,t)

V (r,t) = i ˆ u( x, y,z,t) + ˆ j v( x, y,z,t) + k ˆ w( x, y, z,t) IV. DIFFERENTIAL RELATIONS FOR A FLUID PARTICLE This chapter presents the development and application of the basic differential equations of fluid motion. Simplifications in the general equations and common

More information

Computational non-linear structural dynamics and energy-momentum integration schemes

Computational non-linear structural dynamics and energy-momentum integration schemes icccbe 2010 Nottingham University Press Proceedings of the International Conference on Computing in Civil and Building Engineering W Tizani (Editor) Computational non-linear structural dynamics and energy-momentum

More information

Scientific Computing II

Scientific Computing II Scientific Computing II Molecular Dynamics Simulation Michael Bader SCCS Summer Term 2015 Molecular Dynamics Simulation, Summer Term 2015 1 Continuum Mechanics for Fluid Mechanics? Molecular Dynamics the

More information

Physical Dynamics (SPA5304) Lecture Plan 2018

Physical Dynamics (SPA5304) Lecture Plan 2018 Physical Dynamics (SPA5304) Lecture Plan 2018 The numbers on the left margin are approximate lecture numbers. Items in gray are not covered this year 1 Advanced Review of Newtonian Mechanics 1.1 One Particle

More information

Hamiltonian Mechanics

Hamiltonian Mechanics Alain J. Brizard Saint Michael's College Hamiltonian Mechanics 1 Hamiltonian The k second-order Euler-Lagrange equations on con guration space q =(q 1 ; :::; q k ) d @ _q j = @q j ; (1) can be written

More information

Density Functional Theory: from theory to Applications

Density Functional Theory: from theory to Applications Density Functional Theory: from theory to Applications Uni Mainz May 14, 2012 All electrons vs pseudopotentials Classes of Basis-set Condensed phase: Bloch s th and PBC Hamann-Schlüter-Chiang pseudopotentials

More information

PHYS 705: Classical Mechanics. Hamiltonian Formulation & Canonical Transformation

PHYS 705: Classical Mechanics. Hamiltonian Formulation & Canonical Transformation 1 PHYS 705: Classical Mechanics Hamiltonian Formulation & Canonical Transformation Legendre Transform Let consider the simple case with ust a real value function: F x F x expresses a relationship between

More information

Chapter 6: Momentum Analysis

Chapter 6: Momentum Analysis 6-1 Introduction 6-2Newton s Law and Conservation of Momentum 6-3 Choosing a Control Volume 6-4 Forces Acting on a Control Volume 6-5Linear Momentum Equation 6-6 Angular Momentum 6-7 The Second Law of

More information

Electric and Magnetic Forces in Lagrangian and Hamiltonian Formalism

Electric and Magnetic Forces in Lagrangian and Hamiltonian Formalism Electric and Magnetic Forces in Lagrangian and Hamiltonian Formalism Benjamin Hornberger 1/26/1 Phy 55, Classical Electrodynamics, Prof. Goldhaber Lecture notes from Oct. 26, 21 Lecture held by Prof. Weisberger

More information

Classical Mechanics. Luis Anchordoqui

Classical Mechanics. Luis Anchordoqui 1 Rigid Body Motion Inertia Tensor Rotational Kinetic Energy Principal Axes of Rotation Steiner s Theorem Euler s Equations for a Rigid Body Eulerian Angles Review of Fundamental Equations 2 Rigid body

More information

Chapter 21 Rigid Body Dynamics: Rotation and Translation about a Fixed Axis

Chapter 21 Rigid Body Dynamics: Rotation and Translation about a Fixed Axis Chapter 21 Rigid Body Dynamics: Rotation and Translation about a Fixed Axis Chapter 21 Rigid Body Dynamics: Rotation and Translation about a Fixed Axis... 2 21.1 Introduction... 2 21.2 Translational Equation

More information

NONLINEAR MECHANICAL SYSTEMS LAGRANGIAN AND HAMILTONIAN FORMULATIONS. Lagrangian formulation. Ek * (f,q) = 1 2 f t I(q) f

NONLINEAR MECHANICAL SYSTEMS LAGRANGIAN AND HAMILTONIAN FORMULATIONS. Lagrangian formulation. Ek * (f,q) = 1 2 f t I(q) f NONLINEAR MECHANICAL SYSTEMS LAGRANGIAN AND HAMILTONIAN FORMULATIONS q f Lagrangian formulation Ek * (f,q) = 1 2 f t I(q) f generalized coordinates (displacement) generalized velocity (flow) Ek * (f,q)

More information

EQUIVALENT SINGLE-DEGREE-OF-FREEDOM SYSTEM AND FREE VIBRATION

EQUIVALENT SINGLE-DEGREE-OF-FREEDOM SYSTEM AND FREE VIBRATION 1 EQUIVALENT SINGLE-DEGREE-OF-FREEDOM SYSTEM AND FREE VIBRATION The course on Mechanical Vibration is an important part of the Mechanical Engineering undergraduate curriculum. It is necessary for the development

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

A NOTE ON RELATIONSHIP BETWEEN FIXED-POLE AND MOVING-POLE APPROACHES IN STATIC AND DYNAMIC ANALYSIS OF NON-LINEAR SPATIAL BEAM STRUCTURES

A NOTE ON RELATIONSHIP BETWEEN FIXED-POLE AND MOVING-POLE APPROACHES IN STATIC AND DYNAMIC ANALYSIS OF NON-LINEAR SPATIAL BEAM STRUCTURES European Congress on Computational Methods in Applied Sciences and Engineering (ECCOMAS 212) J. Eberhardsteiner et.al. (eds.) Vienna, Austria, September 1-14, 212 A NOTE ON RELATIONSHIP BETWEEN FIXED-POLE

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

Lecture 38: Equations of Rigid-Body Motion

Lecture 38: Equations of Rigid-Body Motion Lecture 38: Equations of Rigid-Body Motion It s going to be easiest to find the equations of motion for the object in the body frame i.e., the frame where the axes are principal axes In general, we can

More information

Physics 312, Winter 2007, Practice Final

Physics 312, Winter 2007, Practice Final Physics 312, Winter 2007, Practice Final Time: Two hours Answer one of Question 1 or Question 2 plus one of Question 3 or Question 4 plus one of Question 5 or Question 6. Each question carries equal weight.

More information

Rotational motion of a rigid body spinning around a rotational axis ˆn;

Rotational motion of a rigid body spinning around a rotational axis ˆn; Physics 106a, Caltech 15 November, 2018 Lecture 14: Rotations The motion of solid bodies So far, we have been studying the motion of point particles, which are essentially just translational. Bodies with

More information

112 Dynamics. Example 5-3

112 Dynamics. Example 5-3 112 Dynamics Gravity Joint 1 Figure 6-7: Remotely driven two d.o.r. planar manipulator. Note that, since no external force acts on the endpoint, the generalized forces coincide with the joint torques,

More information

PHYS 705: Classical Mechanics. Rigid Body Motion Introduction + Math Review

PHYS 705: Classical Mechanics. Rigid Body Motion Introduction + Math Review 1 PHYS 705: Classical Mechanics Rigid Body Motion Introduction + Math Review 2 How to describe a rigid body? Rigid Body - a system of point particles fixed in space i r ij j subject to a holonomic constraint:

More information

Dynamics of Rotational Motion

Dynamics of Rotational Motion Chapter 10 Dynamics of Rotational Motion To understand the concept of torque. To relate angular acceleration and torque. To work and power in rotational motion. To understand angular momentum. To understand

More information

Cross Product Angular Momentum

Cross Product Angular Momentum Lecture 21 Chapter 12 Physics I Cross Product Angular Momentum Course website: http://faculty.uml.edu/andriy_danylov/teaching/physicsi IN THIS CHAPTER, you will continue discussing rotational dynamics

More information

Dynamics and control of mechanical systems

Dynamics and control of mechanical systems Dynamics and control of mechanical systems Date Day 1 (03/05) - 05/05 Day 2 (07/05) Day 3 (09/05) Day 4 (11/05) Day 5 (14/05) Day 6 (16/05) Content Review of the basics of mechanics. Kinematics of rigid

More information

Introduction to String Theory ETH Zurich, HS11. 9 String Backgrounds

Introduction to String Theory ETH Zurich, HS11. 9 String Backgrounds Introduction to String Theory ETH Zurich, HS11 Chapter 9 Prof. N. Beisert 9 String Backgrounds Have seen that string spectrum contains graviton. Graviton interacts according to laws of General Relativity.

More information

Università degli Studi di Bari. mechanics 1. Load system determination. Joint load. Stress-strain distribution. Biological response 2/45 3/45

Università degli Studi di Bari. mechanics 1. Load system determination. Joint load. Stress-strain distribution. Biological response 2/45 3/45 Università degli Studi di Bari mechanics 1 Load system determination Joint load Stress-strain distribution Biological response 2/45 3/45 ? 4/45 The human body machine Energy transformation Work development

More information

Dynamic force matching: Construction of dynamic coarse-grained models with realistic short time dynamics and accurate long time dynamics

Dynamic force matching: Construction of dynamic coarse-grained models with realistic short time dynamics and accurate long time dynamics for resubmission Dynamic force matching: Construction of dynamic coarse-grained models with realistic short time dynamics and accurate long time dynamics Aram Davtyan, 1 Gregory A. Voth, 1 2, a) and Hans

More information

Physical Simulation. October 19, 2005

Physical Simulation. October 19, 2005 Physical Simulation October 19, 2005 Objects So now that we have objects, lets make them behave like real objects Want to simulate properties of matter Physical properties (dynamics, kinematics) [today

More information