Math 692A: Geometric Numerical Integration

Size: px
Start display at page:

Download "Math 692A: Geometric Numerical Integration"

Transcription

1 Math 692A: Geometric Numerical Integration Melvin Leok Mathematics, Purdue University. mleok/ Mathematics, Purdue University NSF DMS-54747, and DMS

2 The Mathematics of Falling Cats 2

3 Connections, Curvature, and Geometric Phase Connections Connections provide a means of comparing elements of a fiber based at different points on the manifold. 3 Holonomy and Curvature Geometric Phase is an example of holonomy. Curvature can be thought of as infinitesimal holonomy. finish start area = A

4 4 Example of Holonomy Vatican Museum double helical staircase designed by Giuseppe Momo in 1932.

5 Geometric Control of Spacecraft Geometric Phase based controllers Shape controlled using internal momentum wheels and gyroscopes. Changes in shape result in corresponding changes in orientation. More precise than chemical propulsion based orientation control. rigid carrier 5 spinning rotors

6 Geometric Control of Spacecraft 6

7 Shape Dynamics of Formations of Satellites NASA Terrestrial Planet Finder (TPF) The NASA Terrestrial Planet Finder (TPF) and the ESA Darwin missions are examples of a potential application of the geometric formation control of satellite clusters. 7 Small satellites in arranged in a formation to yield a large effective aperture telescope. Courtesy NASA/JPL-Caltech. Artist s conception of the ESA Darwin flotilla. Courtesy ESA. It is quite natural to think of controlling the shape of the cluster, and its orientation (group) separately.

8 Numerically implementing geometric control algorithms Demand for long-time stability in control algorithms Trend towards autonomous space and underwater vehicle missions with long deployment times and low energy propulsion systems. Small inaccuracies in the control algorithms accumulated over long times will significantly diminish the operational lifespan of such missions. Need for geometric integrators to efficiently achieve good qualitative results for simulations over long times. 8

9 Geometry and Numerical Methods Dynamical equations preserve structure Many continuous systems of interest have properties that are conserved by the flow: Energy Symmetries, Reversibility, Monotonicity Momentum - Angular, Linear, Kelvin Circulation Theorem. Symplectic Form Integrability At other times, the equations themselves are defined on a manifold, such as a Lie group, or more general configuration manifold of a mechanical system, and the discrete trajectory we compute should remain on this manifold, since the equations may not be well-defined off the surface. 9

10 Motivation: Geometric Integration Main Goal of Geometric Integration: Structure preservation in order to reproduce long time behavior. Role of Discrete Structure-Preservation: Discrete conservation laws impart long time numerical stability to computations, since the structure-preserving algorithm exactly conserves a discrete quantity that is always close to the continuous quantity we are interested in. 1

11 11 Geometric Integration: Energy Stability Energy stability for symplectic integrators Control on global error Continuous energy Isosurface Discrete energy Isosurface

12 Geometric Integration: Energy Stability Energy behavior for conservative and dissipative systems Midpoint Newmark Energy.2.15 Benchmark Variational Explicit Newmark non-variational Runge-Kutta Energy.2.15 Variational.1.1 Runge-Kutta.5.5 Benchmark Time (a) Conservative mechanics Time (b) Dissipative mechanics

13 13 Geometric Integration: Energy Stability Solar System Simulation Forward Euler Inverse Euler Symplectic Euler q k+1 = q k + h q(q k, p k ), p k+1 = p k + hṗ(q k, p k ). q k+1 = q k + h q(q k+1, p k+1 ), p k+1 = p k + hṗ(q k+1, p k+1 ). q k+1 = q k + h q(q k, p k+1 ), p k+1 = p k + hṗ(q k, p k+1 ).

14 14 Geometric Integration: Energy Stability Forward Euler Energy error

15 15 Geometric Integration: Energy Stability Inverse Euler Energy error

16 16 Geometric Integration: Energy Stability Symplectic Euler x Energy error

17 Introduction to Computational Geometric Mechanics Geometric Mechanics Differential geometric and symmetry techniques applied to the study of Lagrangian and Hamiltonian mechanics. Computational Geometric Mechanics Constructing computational algorithms using ideas from geometric mechanics. Variational integrators based on discretizing Hamilton s principle, automatically symplectic and momentum preserving. 17

18 Introduction to Computational Geometric Mechanics Why adopt this approach? Provides a systematic framework to construct structure-preserving numerical schemes that are consistent with the underlying geometry of the problem. Structure-preservation can be important from the point of view of stability, accuracy, and efficiency. Provides insight into the discrete analogues of differential geometric structures that are preserved by numerical schemes. 18

19 Traditional Approach Discrete Mechanics Discretization is performed at the level of the equation, for example, finite-differences and finite-elements applied to the differential equations of motion. Alternative Approach Discretize underlying variational principles. 19

20 Continuous Mechanics Lagrangian Formulation of Mechanics Given a Lagrangian L : T Q R, the solution curve satisfies Hamilton s variational principle, δ t1 t L (q (t), q (t)) dt =. This is equivalent to the Euler-Lagrange equation, d L dt q L q =. When the Lagrangian has the form L = 1 2 qt M q V (q), this reduces to Newton s Second Law, d dt (M q) = V q. 2

21 Discrete Mechanics Discretization of Mechanics Approximate T Q by Q Q. Diagonal group action of G on Q Q The discrete Lagrangian L d : Q Q R is a generating function of the discrete flow. A particularly simple choice of discrete Lagrangian is given by, ( qk+1 + q L d (q k, q k+1 ) = h L k, q ) k+1 q k 2 h Consider the discrete action sum S : Q N+1 R defined by S = N 1 k= L d (q k, q k+1 ). which is a discrete analogue of the action integral. 21

22 Discrete Mechanics Discrete Variational Principle Hamilton s variational principle states that the solution curve has an action integral that is stationary. Analogously, the discrete variational principle states that, δ N 1 k= L d (q k, q k+1 ) =. 22

23 23 Discrete Mechanics Discrete Variational Principle q(t) varied curve Q q(a) δq(t) q(b) q i varied point Q q N q δq i

24 24 Discrete Mechanics Discrete Euler-Lagrange equation To extremize S over q,, q N, we set This implies, S q k =, k =,..., N. D 1 L d (q k, q k+1 ) δq k +D 2 L d (q k 1, q k ) δq k =, k = 1,..., N 1. Since δq = δq N = and the rest of the variations are arbitrary, we obtain the discrete Euler-Lagrange equation, D 1 L d Φ + D 2 L d =.

25 Correspondance between discrete and continuous mechanics Consider the exact discrete Lagrangian given by, L d (q k, q k+1 ) = tk+1 t k L (q (t), q (t)) dt where q : [t k, t k+1 ] Q is a solution of the Euler-Lagrange equations for L which satisfies the boundary conditions q (t k ) = q k and q (t k+1 ) = q k+1. This choice is motived by the Jacobi solution of Hamilton- Jacobi Theory, where the action integral is a generating function of the Hamiltonian flow. 25

26 Correspondance between discrete and continuous mechanics. Can show that with the exact discrete Lagrangian, the discrete curve {q k } n k= satisfying the Discrete Euler-Lagange equations discretely sample the continuous solution curve q(t) of the Euler- Lagrange equations for the corresponding Lagrangian. q k = q (t k ) In practice, the exact discrete Lagrangian, like Jacobi s solution, cannot be computed exactly. As such, numerical quadrature methods are used to approximate the exact discrete Lagrangian. Can be shown that a discrete Lagrangian given by an n-th order accurate quadrature method yields an n-th order accurate symplectic integrator. This recovers a class of previously discovered Symplectic Partitioned Runger-Kutta methods. 26

27 Canonical Symplectic Structure Hamilton s Canonical Equations q i = H p i ṗ i = H q i If we adopt the coordinate system, z = (q, p), the Canonical Symplectic Form, Ω = dp i dq i has the matrix representation given by: ( ) 1 J = 1 Hamilton s equations, ż = X H = J H can be written as: Ω (X H (z), v) = dh.z 27

28 28 Fiber Derivative Discrete Symplectic Structure FL d : Q Q T Q (q, q 1 ) (q, D 1 L d (q, q 1 )) Discrete Symplectic Form ω L = (FL d ) (Ω L ) = d ((FL ( d ) p i dq i)) ( ) = d L d q i k = 2 L d q i k qj k+1 (q k, q k+1 ) dq i k (q k, q k+1 ) dq i k dqj k+1

29 Momentum Maps Continuous Momentum Map A momentum map J : T Q g is a generalization of the familar conjugate momentum in Hamiltonian mechanics. Given a mechanical system that is invariant under the action of the Lie group G on the configuration manifold Q, we define a momentum map by, J ( αq ), ξ αq, ξ Q (q) 29 Discrete Momentum Map Discrete Momentum Map J d : Q Q g, J d (q k, q k+1 ), ξ D 1 L d (q k, q k+1 ), ξ Q (q k )

30 3 Momentum Maps Example: Angular Momentum Let SO(3) act on R 3 by matrix multiplication. A q = Aq The infinitesimal generator is given by ˆω R 3(q) = ˆωq = ω q, where ω R 3. The momentum map J : T R 3 so(3) = R 3 is given by, that is, J(q, p), ω = p ˆωq = ω (q p), J(q, p) = q p, which is the familiar expression for angular momentum.

31 31 Discrete Mechanics What does this way of thinking buy you? Systematic method of constructing symplectic-momentum integrators of arbitrarily high-order. In contrast to non-constructive condition on the coefficients of the partitioned Runge Kutta scheme: b i ã ij + b j a ji = b i bj, i, j = 1,..., s, b i = b i, i = 1,... s. Naturally leads to generalized schemes such as Lie group, multiscale, and pseudospectral variational integrators.

32 Comparing representations of the rotation group Euler Angles Local coordinate chart, exhibits singularities. Requires change of charts to simulate large attitude maneuvers. Unit Quaternions Reprojection used to stay on unit 3-sphere. The 3-sphere is a double-cover of SO(3) which causes topological problems for optimization. Rotation Matrices 9 dimensional space (3 3 matrices) with a 6 dimensional constraint (orthogonality), but the exponential map saves the day. 32

33 Basic Idea Variational Lie Group Techniques To stay on the Lie group, we parametrize the curve by the initial point g, and elements of the Lie algebra ξ i, such that, ( ) g d (t) = exp ξ s lκ,s (t) This involves standard interpolatory methods on the Lie algebra that are lifted to the group using the exponential map. Automatically stays on SO(n) without the need for reprojection, constraints, or local coordinates. Order of accuracy of method is independent of the retraction, as the variational principle is at the level of the Lie group, and the retraction is simply used to locally parametrize the group. g 33

34 34 Model Problem 3D Pendulum A rigid body, with a pivot point and a center of mass that are not collocated, under gravitational forces. Three degrees of freedom. Exhibits surprisingly rich and complex dynamics.

35 35 Physical Realization of a 3D Pendulum Triaxial Attitude Control Testbed Attitude Dynamics and Control Laboratory, University of Michigan, Ann Arbor.

36 36 Example of a Lie Group Variational Integrator 3D Pendulum Lagrangian L(R, ω) = 1 2 Body ( ρ)ω 2 dm V (R), where : R 3 R 3 3 is a skew mapping such that xy = x y. Equations of motion where M = V T R R R T V R. J ω + ω Jω = M, Ṙ = R ω.

37 37 Example of a Lie Group Variational Integrator 3D Pendulum Discrete Lagrangian L d (R k, F k ) = 1 h tr [(I 3 3 F k )J d ] h 2 V (R k) h 2 V (R k+1). Discrete Equations of Motion Jω k+1 = Fk T Jω k + hm k+1, S(Jω k ) = 1 ( ) F h k J d J d Fk T R k+1 = R k F k.,

38 38 Example of a Lie Group Variational Integrator Automatically staying on the rotation group The magic begins with the ansatz, F k = exp( f k ), and the Rodrigues formula, which converts the equation, Ĵω k = 1 ( ) F h k J d J d Fk T, into hjω k = sin f k f k Jf k + 1 cos f k f k 2 f k Jf k. Since F k is the exponential of a skew matrix, it is a rotation matrix, and by matrix multiplication R k+1 = R k F k is a rotation matrix.

39 39 Numerical Simulation Chaotic Motion of a 3D Pendulum

40 4 Flyby of two dumbbells Numerical Simulations

41 41 Numerical Simulations Effect of representations (Runge-Kutta) 4 3 T ro t T tran 4 3 T ro t T tran T 2 T T U E 4 2 T U E E E t Runge-Kutta with quaternions t Runge-Kutta with Euler angles

42 42 Numerical Simulations Effect of representations (Runge-Kutta) 4 3 T 2 T ro t T tran ΔE 3 x E 2 T U E SO(3) error 6 x I R T R I R T 2 R t Runge-Kutta with SO(3) t Runge-Kutta with SO(3) (Integration error)

43 43 Numerical Simulations Lie group variational integrator on SO(3) 4 3 T ro t T tran T T U E E 2 Trajectory in inertial frame t Transfer of energy

44 44 Numerical Simulations Conservation Properties: Lie Group Integrator ΔĒ 6 14 x t deviation in total energy norm(i R T R) norm(i R 2 T R2 ) x t error in the rotation matrix

45 45 Numerical Simulations Conservation Properties: Lie Group Integrator 5 x Δ γ T 5 x x t deviation in total linear momentum 1 1 x Δ π T 5 x x t deviation in total angular momentum

46 Numerical Simulations Comparison with other methods Our Lie group variational integrator (LGVI) is a Lie Störmer Verlet method, so it is a second-order symplectic Lie group method. We compare it to other second-order accurate methods: Explicit Midpoint Rule (RK): Preserves neither symplectic nor Lie group properties. Implicit Midpoint Rule (SRK): Symplectic but does not preserve Lie group properties. Crouch-Grossman (LGM): Lie group method but not symplectic. 46

47 47 Numerical Simulations Comparison with other methods E.159 RK SRK LGM LGVI mean Δ E RK SRK LGM LGVI time Computed total energy for 3 seconds Step size Mean total energy error E E vs. step size 1 5 mean I R T R CPU time (sec) Step size Mean orthogonality error I R T R vs. step size Step size CPU time vs. step size

48 Applications to Asteroid Simulations Computational Considerations Asteroids are approximated by rubble piles (hard sphere models) or simplicial complexes. Force evaluations using fast multipole methods or polyhedral potential techniques. Computational cost is dominated by cost of force evaluation. Lie Störmer Verlet variational integrators use only one force evaluation per timestep, and are only implicit in the attitude, and converge in 2-3 Newton steps. Used by Scheeres, et al. to accurately simulate binary near-earth Asteroid (1999 KW4). 48

49 Applications to Asteroid Simulations 49

50 Numerically implementing geometric control algorithms Traditional approach Local analysis of the connection near the desired shape position. Gives a closed form expression for the geometric phase associated with infinitesimally small loops in shape space. Resulting shape trajectories are often suboptimal and slow. Alternative approach Homotopy-based optimal control algorithm using geometrically exact numerical schemes. Allows for large-amplitude trajectories that are global in nature, and more efficient than infinitesimal loops. 5

51 51 Essential Ideas Discrete Optimal Control Use the discrete Lagrange d Alembert principle, δ L d (q k, q k+1 ) + F d (q k, q k+1 ) (δq k, δq k+1 ) =, to derive the discrete forced Euler Lagrange equations, and impose these as constraints at every time-step. This yields greater fidelity to the equations of motion that imposing the dynamical constraints using the method of collocation. The resulting numerical solutions are group equivariant, which implies that the numerical solutions are independent of the choice of coordinate frame.

52 Shooting based optimization using variational integrators General approach Relax terminal boundary conditions, and guess initial control torque. Evolve attitude and control torques using equations of motion and optimality conditions. Compute sensitivity of terminal boundary conditions on initial control torques, and iterate to convergence. Robust computation of sensitivities Structure preserving properties of the variational integrator allow the robust computation of sensitivities. Problems considered do not appear to require multiple shooting to achieve convergence. 52

53 53 Under-actuated control of a 3D pendulum 2 u (Nm) Attitude Maneuver t (sec) Control input u Ω (rad/sec) Error t (sec) Angular velocity Ω Iteration Convergence rate

54 Under-actuated control of a 3D pendulum 54

55 Under-actuated control with symmetry of a 3D pendulum

56 Under-actuated control with symmetry of a 3D pendulum

57 Constrained variations Variational Integrators on S 2 The condition that q S 2 = {q R 3 q q = 1} yields a constrained variation of q in the variational principle. δq = ξ q, where ξ R 3 is constrained to be orthogonal to q, i.e., ξ q =. Lagrangian The configuration space is a cartesian product of two-spheres, Q = (S 2 ) n, and the Lagrangian has the form, L(q 1,..., q n, q 1,..., q n ) = 1 n q T 2 j M ij q i V (q 1,..., q n ), i,j=1 57

58 Variational Integrators on S 2 Spherical Pendulum [ ( r k+1 = hω k + h2 g ) 2l r k e 3 r k + r k 1 hω k + h2 g 2l r 2 k r 3 ω k+1 =ω k + hg 2l r k e 3 + hg 2l r k+1 e 3 Double Spherical Pendulum 2 1+f 1 f 1 I 3 3 2α 2β 2 1+f 1 f 1 ˆr 2ˆr 1 1+f 2 f 2 I 3 3 ] [f1 ] 1+f 2 f 2 ˆr 1ˆr 2 = where α = m 2 m 1 +m 2 l 2 l1 and β = l 1 l2. f 2 [ ] hω1k hα(r 1k (r 2k ω 2k )) + h2 g 2l 1 (r 1k e 3 ) + 2αf 2 f 2 1+f 2 f 2 ˆr 1 r 2 hω 2k hβ(r 2k (r 1k ω 1k )) + h2 g 2l 2 (r 2k e 3 ) + 2βf 1 f 1 1+f 1 f 1 ˆr 2 r 1 r 1k+1 = (I ˆf 1 )(I 3 3 ˆf 1 ) 1 r 1k r 2k+1 = (I ˆf 2 )(I 3 3 ˆf 2 ) 1 r 2k Implicit system of equations can be solved using fixed-point iteration, and requires about 5-6 iterations to reach machine precision. 58

59 59 Variational Integrators for S 2 Double Spherical Pendulum Simulation

60 6 Elastic Rod Variational Integrators for S 2

61 61 Variational Integrators for S 2 Coupled Spherical Pendula

62 62 Variational Integrators for S 2 3-body problem on the sphere

63 63 Magnetic Arrays Variational Integrators for S 2

64 Towards Larger-Scale Scientific Computing Problems Hierarchical Multi-Resolution Lie Group VIs General framework motivated by multiscale multiphysics methods. Based on the use of empirical shape functions obtained from localized simulations. Decompose a strand of DNA into its constituent nucleotides, and simulate the free nucleotide dynamics to obtain shape functions. Incorporate empirical shape functions into larger scale simulation using rigid body deformations of lower level solutions. Rigid-body motions form a closed category under recursion. Allows for computational compression by reusing redundant computations. 64

65 65 Towards Larger-Scale Scientific Computing Problems Hierarchical Multi-Resolution Lie Group VIs Schematic of hierarchical method Strand of DNA composed of nucleotides

Computational Geometric Uncertainty Propagation for Hamiltonian Systems on a Lie Group

Computational Geometric Uncertainty Propagation for Hamiltonian Systems on a Lie Group Computational Geometric Uncertainty Propagation for Hamiltonian Systems on a Lie Group Melvin Leok Mathematics, University of California, San Diego Foundations of Dynamics Session, CDS@20 Workshop Caltech,

More information

Towards Discrete Exterior Calculus and Discrete Mechanics for Numerical Relativity

Towards Discrete Exterior Calculus and Discrete Mechanics for Numerical Relativity Towards Discrete Exterior Calculus and Discrete Mechanics for Numerical Relativity Melvin Leok Mathematics, University of Michigan, Ann Arbor. Joint work with Mathieu Desbrun, Anil Hirani, and Jerrold

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

Discrete Dirac Mechanics and Discrete Dirac Geometry

Discrete Dirac Mechanics and Discrete Dirac Geometry Discrete Dirac Mechanics and Discrete Dirac Geometry Melvin Leok Mathematics, University of California, San Diego Joint work with Anthony Bloch and Tomoki Ohsawa Geometric Numerical Integration Workshop,

More information

Melvin Leok: Research Summary

Melvin Leok: Research Summary Melvin Leok: Research Summary My research is focused on developing geometric structure-preserving numerical schemes based on the approach of geometric mechanics, with a view towards obtaining more robust

More information

Lie group variational integrators for the full body problem in orbital mechanics

Lie group variational integrators for the full body problem in orbital mechanics Celestial Mech Dyn Astr (2007) 98:121 144 DOI 10.1007/s10569-007-9073-x ORIGINAL ARTICLE Lie group variational integrators for the full body problem in orbital mechanics Taeyoung Lee Melvin Leok N. Harris

More information

Chaotic motion. Phys 750 Lecture 9

Chaotic motion. Phys 750 Lecture 9 Chaotic motion Phys 750 Lecture 9 Finite-difference equations Finite difference equation approximates a differential equation as an iterative map (x n+1,v n+1 )=M[(x n,v n )] Evolution from time t =0to

More information

Curves in the configuration space Q or in the velocity phase space Ω satisfying the Euler-Lagrange (EL) equations,

Curves in the configuration space Q or in the velocity phase space Ω satisfying the Euler-Lagrange (EL) equations, Physics 6010, Fall 2010 Hamiltonian Formalism: Hamilton s equations. Conservation laws. Reduction. Poisson Brackets. Relevant Sections in Text: 8.1 8.3, 9.5 The Hamiltonian Formalism We now return to formal

More information

Geometric Mechanics and Global Nonlinear Control for Multi-Body Dynamics

Geometric Mechanics and Global Nonlinear Control for Multi-Body Dynamics Geometric Mechanics and Global Nonlinear Control for Multi-Body Dynamics Harris McClamroch Aerospace Engineering, University of Michigan Joint work with Taeyoung Lee (George Washington University) Melvin

More information

Chaotic motion. Phys 420/580 Lecture 10

Chaotic motion. Phys 420/580 Lecture 10 Chaotic motion Phys 420/580 Lecture 10 Finite-difference equations Finite difference equation approximates a differential equation as an iterative map (x n+1,v n+1 )=M[(x n,v n )] Evolution from time t

More information

Physics 5153 Classical Mechanics. Canonical Transformations-1

Physics 5153 Classical Mechanics. Canonical Transformations-1 1 Introduction Physics 5153 Classical Mechanics Canonical Transformations The choice of generalized coordinates used to describe a physical system is completely arbitrary, but the Lagrangian is invariant

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

Polyhedral Potential and Variational Integrator Computation of the Full Two Body Problem

Polyhedral Potential and Variational Integrator Computation of the Full Two Body Problem AIAA/AAS Astrodynamics Specialist Conference and Exhibit 21-24 August 2006, Keystone, Colorado AIAA 2006-6289 Polyhedral Potential and Variational Integrator Computation of the Full Two Body Problem Eugene

More information

Review of Lagrangian Mechanics and Reduction

Review of Lagrangian Mechanics and Reduction Review of Lagrangian Mechanics and Reduction Joel W. Burdick and Patricio Vela California Institute of Technology Mechanical Engineering, BioEngineering Pasadena, CA 91125, USA Verona Short Course, August

More information

Global Formulations of Lagrangian and Hamiltonian Dynamics on Embedded Manifolds

Global Formulations of Lagrangian and Hamiltonian Dynamics on Embedded Manifolds 1 Global Formulations of Lagrangian and Hamiltonian Dynamics on Embedded Manifolds By Taeyoung Lee, Melvin Leok, and N. Harris McClamroch Mechanical and Aerospace Engineering, George Washington University,

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

Symplectic integration. Yichao Jing

Symplectic integration. Yichao Jing Yichao Jing Hamiltonian & symplecticness Outline Numerical integrator and symplectic integration Application to accelerator beam dynamics Accuracy and integration order Hamiltonian dynamics In accelerator,

More information

Numerical Algorithms as Dynamical Systems

Numerical Algorithms as Dynamical Systems A Study on Numerical Algorithms as Dynamical Systems Moody Chu North Carolina State University What This Study Is About? To recast many numerical algorithms as special dynamical systems, whence to derive

More information

1 Hamiltonian formalism

1 Hamiltonian formalism 1 Hamiltonian formalism 1.1 Hamilton s principle of stationary action A dynamical system with a finite number n degrees of freedom can be described by real functions of time q i (t) (i =1, 2,..., n) which,

More information

= 0. = q i., q i = E

= 0. = q i., q i = E Summary of the Above Newton s second law: d 2 r dt 2 = Φ( r) Complicated vector arithmetic & coordinate system dependence Lagrangian Formalism: L q i d dt ( L q i ) = 0 n second-order differential equations

More information

September 21, :43pm Holm Vol 2 WSPC/Book Trim Size for 9in by 6in

September 21, :43pm Holm Vol 2 WSPC/Book Trim Size for 9in by 6in 1 GALILEO Contents 1.1 Principle of Galilean relativity 2 1.2 Galilean transformations 3 1.2.1 Admissible force laws for an N-particle system 6 1.3 Subgroups of the Galilean transformations 8 1.3.1 Matrix

More information

Mathematical Models for the Triaxial Attitude Control Testbed

Mathematical Models for the Triaxial Attitude Control Testbed Draft Article (For Engineering Journals) Mathematical Models for the Triaxial Attitude Control Testbed Sangbum Cho, Jinglai Shen, N. Harris McClamroch Department of Aerospace Engineering University of

More information

Stable Manifolds of Saddle Equilibria for Pendulum Dynamics on S 2 and SO(3)

Stable Manifolds of Saddle Equilibria for Pendulum Dynamics on S 2 and SO(3) 2011 50th IEEE Conference on Decision and Control and European Control Conference (CDC-ECC) Orlando, FL, USA, December 12-15, 2011 Stable Manifolds of Saddle Equilibria for Pendulum Dynamics on S 2 and

More information

Chapter 1. Principles of Motion in Invariantive Mechanics

Chapter 1. Principles of Motion in Invariantive Mechanics Chapter 1 Principles of Motion in Invariantive Mechanics 1.1. The Euler-Lagrange and Hamilton s equations obtained by means of exterior forms Let L = L(q 1,q 2,...,q n, q 1, q 2,..., q n,t) L(q, q,t) (1.1)

More information

The Astrojax Pendulum and the N-Body Problem on the Sphere: A study in reduction, variational integration, and pattern evocation.

The Astrojax Pendulum and the N-Body Problem on the Sphere: A study in reduction, variational integration, and pattern evocation. The Astrojax Pendulum and the N-Body Problem on the Sphere: A study in reduction, variational integration, and pattern evocation. Philip Du Toit 1 June 005 Abstract We study the Astrojax Pendulum and the

More information

06. Lagrangian Mechanics II

06. Lagrangian Mechanics II University of Rhode Island DigitalCommons@URI Classical Dynamics Physics Course Materials 2015 06. Lagrangian Mechanics II Gerhard Müller University of Rhode Island, gmuller@uri.edu Creative Commons License

More information

Spacecraft Attitude Control using CMGs: Singularities and Global Controllability

Spacecraft Attitude Control using CMGs: Singularities and Global Controllability 1 / 28 Spacecraft Attitude Control using CMGs: Singularities and Global Controllability Sanjay Bhat TCS Innovation Labs Hyderabad International Workshop on Perspectives in Dynamical Systems and Control

More information

Analytical Mechanics for Relativity and Quantum Mechanics

Analytical Mechanics for Relativity and Quantum Mechanics Analytical Mechanics for Relativity and Quantum Mechanics Oliver Davis Johns San Francisco State University OXPORD UNIVERSITY PRESS CONTENTS Dedication Preface Acknowledgments v vii ix PART I INTRODUCTION:

More information

Dirac Structures and the Legendre Transformation for Implicit Lagrangian and Hamiltonian Systems

Dirac Structures and the Legendre Transformation for Implicit Lagrangian and Hamiltonian Systems Dirac Structures and the Legendre Transformation for Implicit Lagrangian and Hamiltonian Systems Hiroaki Yoshimura Mechanical Engineering, Waseda University Tokyo, Japan Joint Work with Jerrold E. Marsden

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

The Geometry of Euler s equation. Introduction

The Geometry of Euler s equation. Introduction The Geometry of Euler s equation Introduction Part 1 Mechanical systems with constraints, symmetries flexible joint fixed length In principle can be dealt with by applying F=ma, but this can become complicated

More information

Variational principles and Hamiltonian Mechanics

Variational principles and Hamiltonian Mechanics A Primer on Geometric Mechanics Variational principles and Hamiltonian Mechanics Alex L. Castro, PUC Rio de Janeiro Henry O. Jacobs, CMS, Caltech Christian Lessig, CMS, Caltech Alex L. Castro (PUC-Rio)

More information

Oscillatory Motion. Simple pendulum: linear Hooke s Law restoring force for small angular deviations. small angle approximation. Oscillatory solution

Oscillatory Motion. Simple pendulum: linear Hooke s Law restoring force for small angular deviations. small angle approximation. Oscillatory solution Oscillatory Motion Simple pendulum: linear Hooke s Law restoring force for small angular deviations d 2 θ dt 2 = g l θ small angle approximation θ l Oscillatory solution θ(t) =θ 0 sin(ωt + φ) F with characteristic

More information

Oscillatory Motion. Simple pendulum: linear Hooke s Law restoring force for small angular deviations. Oscillatory solution

Oscillatory Motion. Simple pendulum: linear Hooke s Law restoring force for small angular deviations. Oscillatory solution Oscillatory Motion Simple pendulum: linear Hooke s Law restoring force for small angular deviations d 2 θ dt 2 = g l θ θ l Oscillatory solution θ(t) =θ 0 sin(ωt + φ) F with characteristic angular frequency

More information

DISCRETE VARIATIONAL OPTIMAL CONTROL

DISCRETE VARIATIONAL OPTIMAL CONTROL DISCRETE VARIATIONAL OPTIMAL CONTROL FERNANDO JIMÉNEZ, MARIN KOBILAROV, AND DAVID MARTÍN DE DIEGO Abstract. This paper develops numerical methods for optimal control of mechanical systems in the Lagrangian

More information

for changing independent variables. Most simply for a function f(x) the Legendre transformation f(x) B(s) takes the form B(s) = xs f(x) with s = df

for changing independent variables. Most simply for a function f(x) the Legendre transformation f(x) B(s) takes the form B(s) = xs f(x) with s = df Physics 106a, Caltech 1 November, 2018 Lecture 10: Hamiltonian Mechanics I The Hamiltonian In the Hamiltonian formulation of dynamics each second order ODE given by the Euler- Lagrange equation in terms

More information

Modified Equations for Variational Integrators

Modified Equations for Variational Integrators Modified Equations for Variational Integrators Mats Vermeeren Technische Universität Berlin Groningen December 18, 2018 Mats Vermeeren (TU Berlin) Modified equations for variational integrators December

More information

15. Hamiltonian Mechanics

15. Hamiltonian Mechanics University of Rhode Island DigitalCommons@URI Classical Dynamics Physics Course Materials 2015 15. Hamiltonian Mechanics Gerhard Müller University of Rhode Island, gmuller@uri.edu Creative Commons License

More information

HAMILTON S PRINCIPLE

HAMILTON S PRINCIPLE HAMILTON S PRINCIPLE In our previous derivation of Lagrange s equations we started from the Newtonian vector equations of motion and via D Alembert s Principle changed coordinates to generalised coordinates

More information

SYMMETRIES OF ROCKET DYNAMICS. Part 1. Executive Summary 1 1. Equations of Motion 1 2. The Problem to Solve 2. Part 2. Introduction 2 3.

SYMMETRIES OF ROCKET DYNAMICS. Part 1. Executive Summary 1 1. Equations of Motion 1 2. The Problem to Solve 2. Part 2. Introduction 2 3. SYMMETRIES OF ROCKET DYNAMICS ERNEST YEUNG Abstract. I recap the Euler-Poincaré reduction for the Lagrangian of a free (and non-free) rigid body and discuss the constraints and time steps for the Time

More information

DISCRETE MECHANICS AND OPTIMAL CONTROL

DISCRETE MECHANICS AND OPTIMAL CONTROL DISCRETE MECHANICS AND OPTIMAL CONTROL Oliver Junge, Jerrold E. Marsden, Sina Ober-Blöbaum Institute for Mathematics, University of Paderborn, Warburger Str. 1, 3398 Paderborn, Germany Control and Dynamical

More information

Multibody simulation

Multibody simulation Multibody simulation Dynamics of a multibody system (Newton-Euler formulation) Dimitar Dimitrov Örebro University June 8, 2012 Main points covered Newton-Euler formulation forward dynamics inverse dynamics

More information

Dynamics and Stability application to submerged bodies, vortex streets and vortex-body systems

Dynamics and Stability application to submerged bodies, vortex streets and vortex-body systems Dynamics and Stability application to submerged bodies, vortex streets and vortex-body systems Eva Kanso University of Southern California CDS 140B Introduction to Dynamics February 5 and 7, 2008 Fish

More information

BACKGROUND IN SYMPLECTIC GEOMETRY

BACKGROUND IN SYMPLECTIC GEOMETRY BACKGROUND IN SYMPLECTIC GEOMETRY NILAY KUMAR Today I want to introduce some of the symplectic structure underlying classical mechanics. The key idea is actually quite old and in its various formulations

More information

Introduction to Hamiltonian systems

Introduction to Hamiltonian systems Introduction to Hamiltonian systems Marlis Hochbruck Heinrich-Heine Universität Düsseldorf Oberwolfach Seminar, November 2008 Examples Mathematical biology: Lotka-Volterra model First numerical methods

More information

M3-4-5 A16 Notes for Geometric Mechanics: Oct Nov 2011

M3-4-5 A16 Notes for Geometric Mechanics: Oct Nov 2011 M3-4-5 A16 Notes for Geometric Mechanics: Oct Nov 2011 Text for the course: Professor Darryl D Holm 25 October 2011 Imperial College London d.holm@ic.ac.uk http://www.ma.ic.ac.uk/~dholm/ Geometric Mechanics

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

Part II. Classical Dynamics. Year

Part II. Classical Dynamics. Year Part II Year 28 27 26 25 24 23 22 21 20 2009 2008 2007 2006 2005 28 Paper 1, Section I 8B Derive Hamilton s equations from an action principle. 22 Consider a two-dimensional phase space with the Hamiltonian

More information

Lie Group Variational Integrators for the Full Body Problem

Lie Group Variational Integrators for the Full Body Problem Lie Group Variational Integrators for the Full Body Problem arxiv:math/0508365v2 [math.na] 20 Aug 2005 Taeyoung Lee a,1, Melvin Leok b,1, and N. Harris McClamroch a,2 a Department of Aerospace Engineering,

More information

arxiv:math/ v1 [math.oc] 17 Sep 2006

arxiv:math/ v1 [math.oc] 17 Sep 2006 Global Attitude Estimation using Single Direction Measurements Taeyoung Lee, Melvin Leok, N. Harris McClamroch, and Amit Sanyal arxiv:math/0609481v1 [math.oc] 17 Sep 2006 Abstract A deterministic attitude

More information

A DISCRETE THEORY OF CONNECTIONS ON PRINCIPAL BUNDLES

A DISCRETE THEORY OF CONNECTIONS ON PRINCIPAL BUNDLES A DISCRETE THEORY OF CONNECTIONS ON PRINCIPAL BUNDLES MELVIN LEOK, JERROLD E. MARSDEN, AND ALAN D. WEINSTEIN Abstract. Connections on principal bundles play a fundamental role in expressing the equations

More information

Classical Mechanics and Electrodynamics

Classical Mechanics and Electrodynamics Classical Mechanics and Electrodynamics Lecture notes FYS 3120 Jon Magne Leinaas Department of Physics, University of Oslo 2 Preface FYS 3120 is a course in classical theoretical physics, which covers

More information

3D Pendulum Experimental Setup for Earth-based Testing of the Attitude Dynamics of an Orbiting Spacecraft

3D Pendulum Experimental Setup for Earth-based Testing of the Attitude Dynamics of an Orbiting Spacecraft 3D Pendulum Experimental Setup for Earth-based Testing of the Attitude Dynamics of an Orbiting Spacecraft Mario A. Santillo, Nalin A. Chaturvedi, N. Harris McClamroch, Dennis S. Bernstein Department of

More information

Yuri Fedorov Multidimensional Integrable Generalizations of the nonholonomic Chaplygin sphere problem. November 29, 2006

Yuri Fedorov Multidimensional Integrable Generalizations of the nonholonomic Chaplygin sphere problem. November 29, 2006 Yuri Fedorov Multidimensional Integrable Generalizations of the nonholonomic Chaplygin sphere problem November 29, 2006 1 Preservation of Invariant Measure ẋ = v(x), x = (x 1,..., x n ) ( ) The volume

More information

Lecture Notes - Modeling of Mechanical Systems

Lecture Notes - Modeling of Mechanical Systems Thomas Bak Lecture Notes - Modeling of Mechanical Systems February 19, 2002 Aalborg University Department of Control Engineering Fredrik Bajers Vej 7C DK-9220 Aalborg Denmark 2 Table of Contents Table

More information

Sketchy Notes on Lagrangian and Hamiltonian Mechanics

Sketchy Notes on Lagrangian and Hamiltonian Mechanics Sketchy Notes on Lagrangian and Hamiltonian Mechanics Robert Jones Generalized Coordinates Suppose we have some physical system, like a free particle, a pendulum suspended from another pendulum, or a field

More information

SPECTRAL VARIATIONAL INTEGRATORS

SPECTRAL VARIATIONAL INTEGRATORS SPECTRAL VARIATIONAL INTEGRATORS JAMES HALL AND MELVIN LEOK Abstract. In this paper, we present a new variational integrator for problems in Lagrangian mechanics. Using techniques from Galerkin variational

More information

Numerical Methods for ODEs. Lectures for PSU Summer Programs Xiantao Li

Numerical Methods for ODEs. Lectures for PSU Summer Programs Xiantao Li Numerical Methods for ODEs Lectures for PSU Summer Programs Xiantao Li Outline Introduction Some Challenges Numerical methods for ODEs Stiff ODEs Accuracy Constrained dynamics Stability Coarse-graining

More information

Classical Mechanics and Electrodynamics

Classical Mechanics and Electrodynamics Classical Mechanics and Electrodynamics Lecture notes FYS 3120 Jon Magne Leinaas Department of Physics, University of Oslo December 2009 2 Preface These notes are prepared for the physics course FYS 3120,

More information

5.12 The Aerodynamic Assist Trajectories of Vehicles Propelled by Solar Radiation Pressure References...

5.12 The Aerodynamic Assist Trajectories of Vehicles Propelled by Solar Radiation Pressure References... 1 The Two-Body Problem... 1 1.1 Position of the Problem... 1 1.2 The Conic Sections and Their Geometrical Properties... 12 1.3 The Elliptic Orbits... 20 1.4 The Hyperbolic and Parabolic Trajectories...

More information

Gauge Fixing and Constrained Dynamics in Numerical Relativity

Gauge Fixing and Constrained Dynamics in Numerical Relativity Gauge Fixing and Constrained Dynamics in Numerical Relativity Jon Allen The Dirac formalism for dealing with constraints in a canonical Hamiltonian formulation is reviewed. Gauge freedom is discussed and

More information

Physics 106b/196b Problem Set 9 Due Jan 19, 2007

Physics 106b/196b Problem Set 9 Due Jan 19, 2007 Physics 06b/96b Problem Set 9 Due Jan 9, 2007 Version 3: January 8, 2007 This problem set focuses on dynamics in rotating coordinate systems (Section 5.2), with some additional early material on dynamics

More information

ANALYTICAL MECHANICS. LOUIS N. HAND and JANET D. FINCH CAMBRIDGE UNIVERSITY PRESS

ANALYTICAL MECHANICS. LOUIS N. HAND and JANET D. FINCH CAMBRIDGE UNIVERSITY PRESS ANALYTICAL MECHANICS LOUIS N. HAND and JANET D. FINCH CAMBRIDGE UNIVERSITY PRESS Preface xi 1 LAGRANGIAN MECHANICS l 1.1 Example and Review of Newton's Mechanics: A Block Sliding on an Inclined Plane 1

More information

Analytical Mechanics. of Space Systems. tfa AA. Hanspeter Schaub. College Station, Texas. University of Colorado Boulder, Colorado.

Analytical Mechanics. of Space Systems. tfa AA. Hanspeter Schaub. College Station, Texas. University of Colorado Boulder, Colorado. Analytical Mechanics of Space Systems Third Edition Hanspeter Schaub University of Colorado Boulder, Colorado John L. Junkins Texas A&M University College Station, Texas AIM EDUCATION SERIES Joseph A.

More information

In most robotic applications the goal is to find a multi-body dynamics description formulated

In most robotic applications the goal is to find a multi-body dynamics description formulated Chapter 3 Dynamics Mathematical models of a robot s dynamics provide a description of why things move when forces are generated in and applied on the system. They play an important role for both simulation

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

Experimental Results for Almost Global Asymptotic and Locally Exponential Stabilization of the Natural Equilibria of a 3D Pendulum

Experimental Results for Almost Global Asymptotic and Locally Exponential Stabilization of the Natural Equilibria of a 3D Pendulum Proceedings of the 26 American Control Conference Minneapolis, Minnesota, USA, June 4-6, 26 WeC2. Experimental Results for Almost Global Asymptotic and Locally Exponential Stabilization of the Natural

More information

OPTIMAL ATTITUDE CONTROL OF A RIGID BODY USING GEOMETRICALLY EXACT COMPUTATIONS ON SO(3)

OPTIMAL ATTITUDE CONTROL OF A RIGID BODY USING GEOMETRICALLY EXACT COMPUTATIONS ON SO(3) Journal of Dynamical and Control Systems, Vol. 14, No. 4, October 2008, 465 487 ( c 2008) DOI: 10.1007/s10883-008-9047-7 OPTIMAL ATTITUDE CONTROL OF A RIGID BODY USING GEOMETRICALLY EXACT COMPUTATIONS

More information

Rigid-Body Attitude Control USING ROTATION MATRICES FOR CONTINUOUS, SINGULARITY-FREE CONTROL LAWS

Rigid-Body Attitude Control USING ROTATION MATRICES FOR CONTINUOUS, SINGULARITY-FREE CONTROL LAWS Rigid-Body Attitude Control USING ROTATION MATRICES FOR CONTINUOUS, SINGULARITY-FREE CONTROL LAWS 3 IEEE CONTROL SYSTEMS MAGAZINE» JUNE -33X//$. IEEE SHANNON MASH Rigid-body attitude control is motivated

More information

Hamiltonian. March 30, 2013

Hamiltonian. March 30, 2013 Hamiltonian March 3, 213 Contents 1 Variational problem as a constrained problem 1 1.1 Differential constaint......................... 1 1.2 Canonic form............................. 2 1.3 Hamiltonian..............................

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

Celestial Mechanics of Asteroid Systems

Celestial Mechanics of Asteroid Systems Celestial Mechanics of Asteroid Systems D.J. Scheeres Department of Aerospace Engineering Sciences The University of Colorado scheeres@colorado.edu 1 Granular Mechanics and Asteroids Asteroid systems are

More information

[#1] R 3 bracket for the spherical pendulum

[#1] R 3 bracket for the spherical pendulum .. Holm Tuesday 11 January 2011 Solutions to MSc Enhanced Coursework for MA16 1 M3/4A16 MSc Enhanced Coursework arryl Holm Solutions Tuesday 11 January 2011 [#1] R 3 bracket for the spherical pendulum

More information

Variational integrators for electric and nonsmooth systems

Variational integrators for electric and nonsmooth systems Variational integrators for electric and nonsmooth systems Sina Ober-Blöbaum Control Group Department of Engineering Science University of Oxford Fellow of Harris Manchester College Summerschool Applied

More information

Analytical Dynamics: Lagrange s Equation and its Application A Brief Introduction

Analytical Dynamics: Lagrange s Equation and its Application A Brief Introduction Analytical Dynamics: Lagrange s Equation and its Application A Brief Introduction D. S. Stutts, Ph.D. Associate Professor of Mechanical Engineering Missouri University of Science and Technology Rolla,

More information

IAC-11-C1.5.9 INERTIA-FREE ATTITUDE CONTROL OF SPACECRAFT WITH UNKNOWN TIME-VARYING MASS DISTRIBUTION

IAC-11-C1.5.9 INERTIA-FREE ATTITUDE CONTROL OF SPACECRAFT WITH UNKNOWN TIME-VARYING MASS DISTRIBUTION 6nd International Astronautical Congress, Cape Town, SA. Copyright by the International Astronautical Federation. All rights reserved IAC--C.5.9 INERTIA-FREE ATTITUDE CONTROL OF SPACECRAFT WITH UNKNOWN

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

WEIGHTING MATRICES DETERMINATION USING POLE PLACEMENT FOR TRACKING MANEUVERS

WEIGHTING MATRICES DETERMINATION USING POLE PLACEMENT FOR TRACKING MANEUVERS U.P.B. Sci. Bull., Series D, Vol. 75, Iss. 2, 2013 ISSN 1454-2358 WEIGHTING MATRICES DETERMINATION USING POLE PLACEMENT FOR TRACKING MANEUVERS Raluca M. STEFANESCU 1, Claudiu L. PRIOROC 2, Adrian M. STOICA

More information

GEOMETRIC STRUCTURE-PRESERVING OPTIMAL CONTROL OF A RIGID BODY

GEOMETRIC STRUCTURE-PRESERVING OPTIMAL CONTROL OF A RIGID BODY Journal of Dynamical and Control Systems, Vol. 15, No. 3, July 2009, 307 330 c 2009) DOI: 10.1007/s10883-009-9071-2 GEOMETRIC STRUCTURE-PRESERVING OPTIMAL CONTROL OF A RIGID BODY A. M. BLOCH, I. I. HUSSEIN,

More information

Structural Dynamics Lecture 4. Outline of Lecture 4. Multi-Degree-of-Freedom Systems. Formulation of Equations of Motions. Undamped Eigenvibrations.

Structural Dynamics Lecture 4. Outline of Lecture 4. Multi-Degree-of-Freedom Systems. Formulation of Equations of Motions. Undamped Eigenvibrations. Outline of Multi-Degree-of-Freedom Systems Formulation of Equations of Motions. Newton s 2 nd Law Applied to Free Masses. D Alembert s Principle. Basic Equations of Motion for Forced Vibrations of Linear

More information

Lecture I: Constrained Hamiltonian systems

Lecture I: Constrained Hamiltonian systems Lecture I: Constrained Hamiltonian systems (Courses in canonical gravity) Yaser Tavakoli December 15, 2014 1 Introduction In canonical formulation of general relativity, geometry of space-time is given

More information

From physical assumptions to classical Hamiltonian and Lagrangian particle mechanics

From physical assumptions to classical Hamiltonian and Lagrangian particle mechanics From physical assumptions to classical Hamiltonian and Lagrangian particle mechanics Gabriele Carcassi, Christine A. Aidala, David John Baker and Lydia Bieri University of Michigan Foundations of Physics

More information

Constrained motion and generalized coordinates

Constrained motion and generalized coordinates Constrained motion and generalized coordinates based on FW-13 Often, the motion of particles is restricted by constraints, and we want to: work only with independent degrees of freedom (coordinates) k

More information

Part of the advantage : Constraint forces do no virtual. work under a set of virtual displacements compatible

Part of the advantage : Constraint forces do no virtual. work under a set of virtual displacements compatible FORCES OF CONSTRAINT Lagrangian formalism : Generalized coordinate Minimum set of Eqns Part of the advantage : Constraint forces do no virtual work under a set of virtual displacements compatible with

More information

AN OVERVIEW OF LIE GROUP VARIATIONAL INTEGRATORS AND THEIR APPLICATIONS TO OPTIMAL CONTROL

AN OVERVIEW OF LIE GROUP VARIATIONAL INTEGRATORS AND THEIR APPLICATIONS TO OPTIMAL CONTROL AN OVERVIEW OF LIE GROUP VARIATIONAL INTEGRATORS AND THEIR APPLICATIONS TO OPTIMAL CONTROL MELVIN LEOK Abstract. We introduce a general framewor for te construction of variational integrators of arbitrarily

More information

THE LAGRANGIAN AND HAMILTONIAN MECHANICAL SYSTEMS

THE LAGRANGIAN AND HAMILTONIAN MECHANICAL SYSTEMS THE LAGRANGIAN AND HAMILTONIAN MECHANICAL SYSTEMS ALEXANDER TOLISH Abstract. Newton s Laws of Motion, which equate forces with the timerates of change of momenta, are a convenient way to describe mechanical

More information

Three objects; 2+1 problem

Three objects; 2+1 problem Three objects; 2+1 problem Having conquered the two-body problem, we now set our sights on more objects. In principle, we can treat the gravitational interactions of any number of objects by simply adding

More information

Canonical transformations (Lecture 4)

Canonical transformations (Lecture 4) Canonical transformations (Lecture 4) January 26, 2016 61/441 Lecture outline We will introduce and discuss canonical transformations that conserve the Hamiltonian structure of equations of motion. Poisson

More information

Chapter 2 Math Fundamentals

Chapter 2 Math Fundamentals Chapter 2 Math Fundamentals Part 5 2.8 Quaternions 1 Outline 2.8.1 Representations and Notation 2.7.2 Quaternion Multiplication 2.7.3 Other Quaternion Operations 2.7.4 Representing 3D Rotations 2.7.5 Attitude

More information

Linear Feedback Control Using Quasi Velocities

Linear Feedback Control Using Quasi Velocities Linear Feedback Control Using Quasi Velocities Andrew J Sinclair Auburn University, Auburn, Alabama 36849 John E Hurtado and John L Junkins Texas A&M University, College Station, Texas 77843 A novel approach

More information

SPACECRAFT DYNAMICS NEAR A BINARY ASTEROID. F. Gabern, W.S. Koon and J.E. Marsden

SPACECRAFT DYNAMICS NEAR A BINARY ASTEROID. F. Gabern, W.S. Koon and J.E. Marsden PROCEEDINGS OF THE FIFTH INTERNATIONAL CONFERENCE ON DYNAMICAL SYSTEMS AND DIFFERENTIAL EQUATIONS June 16 19, 2004, Pomona, CA, USA pp. 1 10 SPACECRAFT DYNAMICS NEAR A BINARY ASTEROID F. Gabern, W.S. Koon

More information

Attitude State Estimation with Multi-Rate. Measurements for Almost Global Attitude Feedback. Tracking

Attitude State Estimation with Multi-Rate. Measurements for Almost Global Attitude Feedback. Tracking Attitude State Estimation with Multi-Rate Measurements for Almost Global Attitude Feedback Tracking Amit K. Sanyal 1 Mechanical and Aerospace Engineering, New Mexico State University, Las Cruces, NM 88003

More information

Almost Global Robust Attitude Tracking Control of Spacecraft in Gravity

Almost Global Robust Attitude Tracking Control of Spacecraft in Gravity Almost Global Robust Attitude Tracking Control of Spacecraft in Gravity Amit K. Sanyal Nalin A. Chaturvedi In this paper, we treat the practical problem of tracking the attitude and angular velocity of

More information

Chapter 1 Symplectic Integrator and Beam Dynamics Simulations

Chapter 1 Symplectic Integrator and Beam Dynamics Simulations Chapter 1 and Beam Accelerator Physics Group, Journal Club November 9, 2010 and Beam NSLS-II Brookhaven National Laboratory 1.1 (70) Big Picture for Numerical Accelerator Physics and Beam For single particle

More information

Lagrange-d Alembert integrators for constrained systems in mechanics

Lagrange-d Alembert integrators for constrained systems in mechanics Lagrange-d Alembert integrators for constrained systems in mechanics Conference on Scientific Computing in honor of Ernst Hairer s 6th birthday, Geneva, Switzerland Laurent O. Jay Dept. of Mathematics,

More information

Physics 351, Spring 2017, Homework #12. Due at start of class, Friday, April 14, 2017

Physics 351, Spring 2017, Homework #12. Due at start of class, Friday, April 14, 2017 Physics 351, Spring 2017, Homework #12. Due at start of class, Friday, April 14, 2017 Course info is at positron.hep.upenn.edu/p351 When you finish this homework, remember to visit the feedback page at

More information

Lagrangian and Hamiltonian Dynamics on SO(3)

Lagrangian and Hamiltonian Dynamics on SO(3) Chapter 6 Lagrangian and Hamiltonian Dynamics on SO(3) This chapter treats the Lagrangian dynamics and Hamiltonian dynamics of a rotating rigid body. A rigid body is a collection of mass particles whose

More information

Introduction to Group Theory

Introduction to Group Theory Chapter 10 Introduction to Group Theory Since symmetries described by groups play such an important role in modern physics, we will take a little time to introduce the basic structure (as seen by a physicist)

More information

GEOMETRIC INTEGRATION OF ORDINARY DIFFERENTIAL EQUATIONS ON MANIFOLDS

GEOMETRIC INTEGRATION OF ORDINARY DIFFERENTIAL EQUATIONS ON MANIFOLDS BIT 0006-3835/01/4105-0996 $16.00 2001, Vol. 41, No. 5, pp. 996 1007 c Swets & Zeitlinger GEOMETRIC INTEGRATION OF ORDINARY DIFFERENTIAL EQUATIONS ON MANIFOLDS E. HAIRER Section de mathématiques, Université

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