Chapter 1 Symplectic Integrator and Beam Dynamics Simulations

Size: px
Start display at page:

Download "Chapter 1 Symplectic Integrator and Beam Dynamics Simulations"

Transcription

1 Chapter 1 and Beam Accelerator Physics Group, Journal Club November 9, 2010 and Beam NSLS-II Brookhaven National Laboratory 1.1 (70)

2 Big Picture for Numerical Accelerator Physics and Beam For single particle dynamics: Particle tracking is everything for a complex ring. (integrator) and physics quantities are in the map : betatron oscillation, spin,... Map can be extracted from the tracking. (TPSA) Map analysis gives every quantity we want: twiss, emittance, (normal form) Here we focus on how to calculate the physics, instead of how to use it. 1.2 (70)

3 and Beam (70)

4 and Beam (70)

5 and Beam Implicit s 1.3 (70)

6 and Beam Implicit s (70)

7 Introduction Over the last century (19th) attention has shifted from the computation of individual orbits towards the qualitative properties of families of orbits. For example, the question of whether a given orbit is stable can only be answered by studying the development of all orbits whose initial conditions are in some sense close to those of the orbit being studied. M. V. Berry and Beam The objective is to answer some questions (what-why-how) and to give some real life examples 1 What is symplecticness, in algebra, in geometry? 2 Why we have to use symplectic integrator? 3 How to prove the symplecticness of an integrator? 4 Popular symplectic integrators. 5 Symplectic integrators in beam dynamics. Particle tracking in different magnets. 1.4 (70)

8 Hamilton Equations I and Beam Hamilton equations dq i dt = H p i, dp i dt = H q i, (1) or in a compact form dz dt = J zh(z, t) (2) where z (q, p) T, q, p R d, z R 2d, and ( ) 0 Id J I d 0 The solution is a transformation mapping (flow map): (q, p) = Φ t0 t,h(q 0, p 0 ) or simply φ t,h if we set t 0 = 0 as the starting time. (3) 1.5 (70)

9 Hamilton Equations II and Beam The flow map φ t,h given by a Hamiltonian system has semi-group property, i.e. closed under composition operator: φ t+s,h = φ t,h φ s,h When t = 0, the flow map φ 0,H is the identity map. φ t,h φ t,h = I When using difference method to simulate the evolution of a dynamical system, the time is discretized at t 0, t 1,..., t n, the semi-group property is not exactly hold in general, but only up to certain order of step size. 1.6 (70)

10 Hamiltonian flow maps are symplectic and Beam A transformation (flow map) z = ψ z z is symplectic if [ψ z (z)] T Jψ z (z) = J Theorem (Poincare 1899) The flow map φ t,h (z) of a Hamiltonian system is symplectic Proof. The Jacobian of the flow map F(t) z φ t,h(z) has F(0) = I 2d. K F(t) T JF(t) is a constant, i.e. dk dt = (70)

11 is the preservation of area η T Jξ is the oriented area of the parallelogram determined by η and ξ For a parallelogram P having a fixed vertex at (q, p), and two vectors as sides, η and ξ. The parallelogram P after transformation ψ has sides ψ z η and ψ z ξ. Vertex (q, p) are now ψ(q, p). Now P and P have same area if and only if η T ψ z T Jψ z ξ = η T Jξ Clearly, this holds if and only if ψ z T Jψ z = J and Beam Figure: Symplectic map preserves the area 1.8 (70)

12 Preservation of area: differential forms I We can use differential forms as an alternative language to express the preservation of area. The meaning and properties of differential forms is outside of this discussion of numerical simulation, (Arnold 1989, chapter 7). The algebraic manipulation is easy, and good enough to prove the preservation of area. The wedge product of ω 1 (ξ 1, ξ 2 ) and ω 2 (ξ 1, ξ 2 ) is defined as (ω 1 ω 2 )(ξ 1, ξ 2 ) = ω 11(ξ 1, ξ 2 ) ω 12 (ξ 1, ξ 2 ) ω 21 (ξ 1, ξ 2 ) ω 22 (ξ 1, ξ 2 ) =ω 1 (ξ 1, ξ 2 )ω 2 (ξ 1, ξ 2 ) ω 2 (ξ 1, ξ 2 )ω 1 (ξ 1 ξ 2 ) (4) and Beam It is the oriented area of a parallelogram determined by ω 1 and ω 2 in (ω 1, ω 2 ) plane. 1.9 (70)

13 Preservation of area: differential forms II z = (q, p ) is given by the map ψ z (z), and we have dp = p p dp + p q dq, The wedge product is dp dq = p p + p q dq = q p q p dp dp + p p q p dq dp + p q the wedge product is skew symmetric, q dp + dq (5) q q dp dq q q dq dq q (6) dp dp = dq dq = 0, dp dq = dq dp (7) Then for one degree of freedom (d = 1) dp dq = ( p p q q p q q )dp dq = p p p q p p q q dp dq q (8) and Beam 1.10 (70)

14 Preservation of area: differential forms III The invariant of dp dq is equivalent to det ψ z (q, p) = 1, i.e. the preservation of area. (for 2 2 matrix, det M = 1 is equivalent to M T JM = J). In General case, d > 1, the transformation ψ is symplectic if an only if dp 1 dq dp d dq d = dp 1 dq dp d dq d (9) and Beam or dp dq = dp dq (10) We can use this to check if a numerical algorithm is symplectic or not. Suppose ψ z (z) maps from one iteration z n (t n ) to the next z n+1 (t n+1 ), i.e. an integrator, we can check whether it is symplectic by proving dp n+1 dq n+1? = dpn dq n (11) The concatenated map of two symplectic map is symplectic. This is obvious from the invariant of dp i dq i (70)

15 Remarks on symplecticness and differential two-forms and Beam is an alternative language to describe the preservation of area. For one-degree-of-freedom systems, symplecticness implies preservation of area (differential 2-form). For higher dimensions, the conservation of volume follows from Liouville s theorem (differential 2n-form). is stronger than conservation of volume. In the following sections we can see differential 2-form is easier to use in proving the symplecticness of a numerical integrator (70)

16 Numerical Integrator I A systems of differential equations and Beam dx dt = f(t, x) (12) where x = (x 1, x 2,..., x n ) T and f(t, x) = (f 1 (t, x),..., f n (t, x)) T. Using t as independent variable and evaluate x at discretized time point t 0, t 1,, t n,. We define h i t i = t i t i 1 or simply h as the current step size in each iteration. Explicit Euler (Forward Euler) Implicit Euler (backward Euler) x n+1 = x n + hf(x n ) (13) Implicit Midpoint(symplectic, order 2) x n+1 = x n + hf(x n+1 ) (14) x n+1 = x n + hf( x n + x n+1 ) (15) (70)

17 Numerical Integrator II and Beam Explicit 4th order Runge-Kutta k 1 =f(t n, x n ) k 2 =f(t n + h 2, x n + h 2 k 1) k 3 =f(t n + h 2, x n + h 2 k 2) k 4 =f(t n + h, x n + hk 3 ) x n+1 =x n + h 6 (k 1 + 2k 2 + 2k 3 + k 4 ) (16) 1.14 (70)

18 Euler Method, a simple example, non-hamiltonian and Beam x n+1 = x n + hf(x n ) (17) It is a first-order integrator, therefore x(t n ) will approach the true solution linearly as h (70)

19 Simple Harmonic Oscillator I and Beam For simple harmonic oscillator H = p 2 + q 2 (18) with initial condition q 0 = 0, p 0 = 1, the solution is q = sin t, p = cos t. The period T = 2π. The solutions are circles in phase space, they are concentric for differential initial conditions. What is wrong in the following numerical solutions? 1.16 (70)

20 Simple Harmonic Oscillator II and Beam Figure: Forward Euler method: x n+1 = x n + hf (x n), step size h = 2π/ (70)

21 Simple Harmonic Oscillator III and Beam Figure: Backward (implicit) Euler method: x n+1 = x n + hf (x n+1), step size h = 2π/ (70)

22 Simple Harmonic Oscillator IV and Beam Figure: RK4 method, step size h = 2π/ (70)

23 Simple Harmonic Oscillator V and Beam Figure: RK4 Gauss method (symplectic), step size h = 2π/5. integrate with longer time (70)

24 Pendulum and Beam Figure: Area preservation of the flow of Hamiltonian system [8] 1.21 (70)

25 Lennard-Jones oscillator I and Beam H = T + V, V φ L.J. (r) = ɛ[( r r ) 12 ( r r ) 6 ] (19) Figure: Euler method, h = , 180k steps 1.22 (70)

26 Lennard-Jones oscillator II and Beam Figure: RK4, h = , 180k steps 1.23 (70)

27 Lennard-Jones oscillator III and Beam Figure: Stormer-Verlet, second order, h = , 180k steps (70)

28 Lennard-Jones oscillator IV and Beam Figure: Stormer-Verlet, second order, step size h 2 = 10h = 0.002, 18k steps (70)

29 Some remarks on symplectic integrator and Beam A.K.A Geometric Integrator A.K.A Canonical Integrator. classical theories of numerical integration give information about how well different methods approximate the trajectories for fixed times as step sizes tend to zero. Dynamical systems theory asks questions about asymptotic, i.e. infinite time, behavior. Geometric integrators are methods that exactly conserve qualitative properties associated to the solutions of the dynamical system under study. The difference between symplectic integrators and other methods become most evident when performing long time integrations (or large step size). Symplectic integrators do not usually preserve energy either, but the fluctuations in H from its original value remain small (70)

30 and Beam In general, one size fits all doesn t happen a lot. When solving numerical Hamiltonian problems, we will treat our problems differently. 1 Composition method, if H is separable as solvable pieces, e.g. H(q, p) = T(p) + V(q). 2 Implicit method, if H can not be solved by parts. We start from the general case where H can not be solved by parts (70)

31 Euler-A and Euler-B are symplectic integrator I For Hamilton equations dq dt = ph dp dt = qh (20) Using differential two-forms we can prove Euler-A and Euler-B method described in the following are symplectic. They are first order, but we will not prove here (will not prove any order condition in this talk). Euler-A and Beam q n+1 = q n + t p H(q n+1, p n ) p n+1 = p n t q H(q n+1, p n ) (21) Euler-B q n+1 = q n + t p H(q n, p n+1 ) p n+1 = p n t q H(q n, p n+1 ) (22) 1.28 (70)

32 Euler-A and Euler-B are symplectic integrator II We prove Euler-B is symplectic by proving and Beam dq n+1 dp n+1 = dq n dp n (23) From Equation. (22) we have dq n+1 = dq n + t[h pq dq n + H pp dp n+1 ] (24) dp n+1 = dp n t[h qq dq n + H qp dp n+1 ] (25) where H qp, H pp and H qq are Jacobian matrix H qq = 2 H q i q j, H qp = 2 H q i p j, H pp = 2 H p i p j, Using the skew symmetry and bilinear property H pq = H T qp (26) da db = db da, da (αdb+βdc) = αda db+βda dc (27) We have dq n H qq dq n = 0, dp n H pp dp n = 0 (28) 1.29 (70)

33 Euler-A and Euler-B are symplectic integrator III and Beam dq n+1 dp n+1 = dq n dp n+1 + th pq dq n dp n+1 (29) while dq n dp n+1 = dq n dp n th T qpdq n dp n+1 (30) We used da Adb = (A T da) db (31) So dq n+1 dp n+1 = dq n dp n (32) Euler-B method is symplectic. Similarly we can prove Euler-A is also symplectic. Now, we have a first order, implicit, symplectic integrator. (disappointed at first order and implicit?) How about higher order? 1.30 (70)

34 Runge-Kutta Methods and I The most popular RK4 method can be written as k 1 =f (t n, x n ) k 2 =f (t n + h/2, x n + hk 1 /2) k 3 =f (t n + h/2, x n + hk 2 /2) k 4 =f (t n + h, x n + hk 3 ) x n+1 =x n (k 1 + 2k 2 + 2k 3 + k 4 ) (33) and Beam Figure: Explicit RK4 [8, Hairer 2006] 1.31 (70)

35 Runge-Kutta Methods and II Let b i, a ij, (i, j = 1,..., s) be real numbers and let c i = s j=1 a ij. An s-stage Runge-Kutta method is given by [8] k i = f(t 0 + c i h, x 0 + h x 1 = x 0 + h s a ij k j ), j=1 i = 1,..., s (34) s b i k i i=1 The explicit Runge-Kutta methods have a ij = 0 whenever i j. The coefficients are usually displayed as c 1 a 11 a 1s... c s a s1 a ss b 1 b s and Beam 1.32 (70)

36 Symplectic Runge-Kutta methods I Conditions for symplectic Runge-Kutta methods and Beam Assume the coefficients of the method (34) satisfy the relations b i a ij + b j a ji b i b j = 0, i, j = 1,..., s (35) Then the method is symplectic. The proof using differential forms can be found in ref. [4]. Same as the proof for Euler-A and Euler-B method, we need to prove the differential 2-form is conserved. Now for arbitrary form of H, we have a 4th order symplectic integrator, but it is still implicit as shown in the following lemma. Lemma Symplectic Runge-Kutta methods are necessarily implicit, i.e. a ij 0 for some i, j 1, 2,..., s, j i A class of RK methods usually called Gauss methods meet this condition: 1.33 (70)

37 Symplectic Runge-Kutta methods II and Beam 1 s = 1 1/2 1/2 1 2 s = s = s = 4 can be found in ref. [1] (70)

38 Symplectic Runge-Kutta methods III 1 2 ω2 ω1 ω 1 ω 3 + ω 4 ω 1 ω 3 ω 4 ω 1 ω ω 2 ω 1 ω 3 + ω 4 ω 1 ω 1 ω 5 ω 1 ω 3 ω ω 2 ω 1 + ω 3 + ω 4 ω 1 + ω 5 ω 1 ω 1 + ω 3 ω ω2 ω1 + ω5 ω 1 + ω 3 + ω 4 ω 1 + ω 3 ω 4 ω 1 and Beam 2ω 1 2ω 1 2ω 1 2ω , ω 1 = , ω 1 = , ω 2 = , ω 3 = ω 2 ( ω 2 = 1 2 ω 4 = ω 2 ( ω 5 = ω 2 2ω 3. 5 s = 5 can be found in ref. [1] 24 ), ω 3 = ω 2 ( ), 168, ω 4 = ω 2 ( , ω 5 = ω 2 2ω 3, 1 2 ω2 ω1 ω 1 ω3 + ω ω 2 ω 1 ω 3 + ω4 ω ω 1 + ω 7 ω 1 + ω ω 2 ω 1 + ω 3 + ω4 ω 1 + ω ω2 ω1 + ω6 ω 1 + ω3 + ω ω5 ω 1 ω3 ω 4 ω 1 ω ω 5 ω 1 ω 6 ω 1 ω 3 ω ω 1 ω 7 ω 1 ω ω 5 ω 1 ω 1 + ω 3 ω ω5 ω 1 + ω3 ω 4 ω (70)

39 Symplectic Runge-Kutta methods IV and Beam ω 1 = , ω 1 = , ω 2 = , ω 2 = , ω 3 = ω 2 ( ), ω 3 = ω 2 ( ), ω 4 = ω 2 ( ), ω 4 = ω 2 ( ), ω 5 = 8ω 2 ( ), ω 5 = 8ω 2 ( ), ω 6 = ω 2 2ω 3 ω 5, ω 6 = ω 2 2ω 3 ω 5, ω 7 = ω 2 ( ), ω 7 = ω 2 ( ) (70)

40 Remarks on Integrating a General Hamiltonian System and Beam What we know so far: Explicit Euler method is not symplectic. No explicit RK method is symplectic. Implicit Midpoint method is symplectic. (did not prove) Euler-A and Euler-B are first order symplectic. RK method with Gauss scheme are symplectic These are for general form of f(x). i.e. no special form of Hamiltonian are assumed. What about H(q, p) = T(p) + V(q) or H(q, p) = H 1 (q, p) + H 2 (q, p) where H 1 and H 2 are solvable? We always hear about drift-kick, what does it really mean for symplectic integrator (70)

41 Partitioned Euler Method I If H = T(p) + V(q), then Euler-A and Beam becomes q n+1 = q n + t p H(q n+1, p n ) p n+1 = p n t q H(q n+1, p n ) (36) q n+1 = q n + t p T(p n ) p n+1 = p n t q V(q n+1 ) (37) It is explicit now, and a drift-kick scheme. Euler-B q n+1 = q n + t p H(q n, p n+1 ) p n+1 = p n t q H(q n, p n+1 ) (38) becomes q n+1 = q n + t p T(p n+1 ) p n+1 = p n t q V(q n ) (39) This is a kick-drift scheme 1.38 (70)

42 Stormer-Verlet Scheme and Beam p n+1/2 = p n t 2 qv(q n ) (40) q n+1 = q n + tp n+1/2 (41) p n+1 = p n+1/2 t 2 qv(q n+1 ) (42) We will see that Stormer-Verlet method, which is popular in molecule dynamics simulations, is a second order symplectic integrator (70)

43 Composition and Symmetry I? H = T + V φ t,t+v = φt,t φ t,v If the above is true, for H = T(p) + V(q), the over all order will depend on the integrator used in T(p) and V(q). We may choose a higher order explicit integrator for it. Theorem If H = H 1 + H H n is any splitting into twice differentiable terms, then the composition method Ψ t = φ t,h1 φ t,h2 φ t,hn (43) is (at least) a first order symplectic integrator. This can be proved from the Taylor expansion of φ t,h1 (φ t,h2 (z)). and Beam Even H i are exactly solvable, the overall effect may be only first order (70)

44 Composition and Symmetry II and Beam Here comes the symmetry. The adjoint method of Ψ t is defined by Ψ t = [Ψ t] 1 ( t t, z n z n+1 ). Euler-A is the adjoint method of Euler-B. A method is symmetric if Ψ t = Ψ t. We can prove that Ψ t = Ψ t/2 Ψ t/2 is symmetric. Theorem The order of a symmetric method is necessarily even (nothing to do with the symplecticness). Compose Euler-A and Euler-B together, we have a symmetric second order symplectic integrator. drift(half)-kick(half)-kick(half)-drift(half) (70)

45 Keppler Problems I and Beam H = T(p) + V(q) = p2 1 + p q q 2 2 (44) The solution in polar coordinate is r = a(1 e2 ) 1 ± e cos θ, the a eccentricity of the ellipse is e = 2 b 2 a, a,b are semimajor and 2 semiminor axis (70)

46 Keppler Problems II and Beam Figure: Euler-A and Euler-B, step size h = The angular momentum are exactly conserved, because it is the differential 2-form (70)

47 Keppler Problems III and Beam Figure: RK4, step size h = (70)

48 Keppler Problems IV and Beam Figure: Euler-A and Euler-B, step size h 2 = 10h = With larger step size, quantitatively the results changed, but qualitatively the result did not change (70)

49 Keppler Problems V and Beam Figure: RK4, step size h 2 = 10h = (70)

50 Keppler Problems VI and Beam Figure: Euler-A and Euler-B, step size h 3 = 100h = (70)

51 Keppler Problems VII and Beam Figure: RK4, step size h 3 = 100h = (70)

52 Keppler Problems VIII and Beam Figure: Euler-A and Euler-B, step size h 4 = 120h = (70)

53 Keppler Problems IX and Beam Figure: RK4, step size h 4 = 120h = (70)

54 Keppler Problems X and Beam Figure: SV, step size h 4 = 120h = (70)

55 Generating Function I and Beam R. Ruth and K. Feng developed symplectic integrator independently using generating functions. The generating function methods 1 use generating function to get the iteration scheme, and 2 the new Hamiltonian are approximated to certain order of step size. These two points guarantee the symplecticness and the order. Ruth s method (1983) [2] General Third Order 1.52 (70)

56 Generating Function II H = g(p) + V(x, t), f = x V and Beam p 1 =p 0 + c 1 hf(x 0, t 0 ) p 2 =p 1 + c 2 hf(x 1, t 0 + d 1 h) p =p 2 + c 1 hf(x 0, t 0 ) x 1 =x 0 + d 1 h dg dp (p 1) x 2 =x 1 + d 2 h dg dp (p 2) x 1 =x 0 + d 3 h dg dp (p) (45a) (45b) (45c) where c 1 = 7/24, c 2 = 3/4, c 3 = 1/24, d 1 = 2/3, d 2 = 2/3, d 3 = 1. Feng and Qin (Implicit)[3] p i =p 0 i hh qi ( p + p 0, q + q 0 ) h ! (H p jp kq i H qj H qk + 2H pjp k H qjq i H qk 2H pjq kq i H pj H qk 2H pjq k H pjq i H qk (46a) 2H pjq k H pj H qkq i + 2H qjq k H pjq i H pk + H qjq kq i H pj H pk ) q i =q 0 i + hh pi ( p + p 0 2, q + q 0 ) + h3 2 4! (H p jp kp i H qj H qk (70)

57 Generating Function III and Beam 2H pjp k H qjp i H qk 2H pjq kp i H pj H qk 2H pjq k H pjp i H qk (46b) 2H pjq k H pj H qkp i + H qjq kp i H pj H pk + 2H qjq k H pjp i H pk ) where subscripts of H are partial derivatives, e.g. H pjp kq i = 3 H p j p k q i. Same indices are summed up according to Einstein rules. Solve the wrong problem in a right way K. Feng 1.54 (70)

58 and Yoshida Scheme I and Beam Yoshida developed a method, for H = T(p) + V(q), a 2n-th order symplectic integrator can be constructed from 2(n-1)-th order symplectic integrators. the solution of linear differential equation z = Az is z = e ta e ta e tb e t(a+b) in general Using BCH formula, e ta e tb = e t(a+b)+t2 /2[A,B]+ e td For H = T(p) + V(q), T(p) and V(q) are solvable (as in Euler-A and Euler-B methods) The symmetry can make the integrator be even order. Discretize the time step e hh = e c1ht e d1hv e cnht e dnhv e hk Use BCH form to approximate K to H up to certain order of step size h, and solves for c i and d i. This can be generalized to nonlinear differential equation z = f (z) (70)

59 and Yoshida Scheme II A 2n + 2-order integrator can be constructed by three 2n-order integrators [5]: and Beam S 2n+2 (τ) = S 2n (z 1 τ)s 2n (z 0 τ)s 2n (z 1 τ) (47) where (there is a typo in Yoshida s paper) z 0 = 21/(2n+1) 2 2, z 1 1/(2n+1) 1 = (48) 2 2 1/(2n+1) They are solved from the order condition z 0 + 2z 1 = 1, z 2n z 2n+1 1 = (70)

60 and Yoshida Scheme III and Beam Figure: 2nd order symplectic integrator of Yoshida s scheme. Composed by Euler-A and Euler-B method. Figure: 4th order symplectic integrator of Yoshida s scheme. It is composed by three second order integrators symmetrically (70)

61 and Yoshida Scheme IV and Beam Figure: 6th order symplectic integrator, composed by three 4th order symplectic integrators. The step 4 and 5 can be combined, so can step 8 and (70)

62 Comments on Generating Function and and Beam Yes, using the generating function, we have canonical transformation, it is symplectic. But what about the order? Yes, Lie algebra can give us canonical transformation, e :f : z is symplectic, but e :f : = n=0 1 n! :f :n, it may be not symplectic if the trucation are not careful (70)

63 Transverse Beam I and Beam H = (1 + x ρ ) p 2 (p x ea x ) 2 (p z ea z ) 2 ea s (49) Where s is the independent variable. B x = 1 h s A s z, If p x and p z are small, B z = 1 h s A s x, h s = 1 + x/ρ (50) H p(1 + x ρ ) x/ρ [(p x ea x ) 2 (p z ea z ) 2 ] ea s (51) 2p Divided by p 0, the norminal momentum, δ = (p p 0 )/p 0, choose A x = A z = 0, A s 0, now p x is p x /p 0, p y is p y /p 0. K = (1 + x ρ ) (1 + δ) 2 p 2 x p 2 z ea s p 0 (52) 1.60 (70)

64 Transverse Beam II and Beam For a sector dipole B 0 ρ = e/p 0 for on momentum particle, B x = 0, B z ρ = e/p 0, and eas p 0 = e p 0 B z (x + x2 2ρ ) = x ρ x2 2ρ 2 For drift K = (1 + x ρ ) (1 + δ) 2 p 2 x p 2 z + x ρ + x2 2ρ 2 (53) K 1 = (1 + δ) 2 p 2 x p 2 z (54) 1.61 (70)

65 Transverse Beam III and Beam p x (s) = p x (55) dx ds = p x/ (1 + δ) 2 p 2 x p 2 z (56) p z (s) = p z (57) dz ds = p z/ (1 + δ) 2 p 2 x p 2 z (58) δ(s) = δ (59)? = K 1 δ = 1 + δ (60) (1 + δ)2 p 2 x p 2 z (61) 1.62 (70)

66 Transverse Beam IV For dipoles, it is not in the form of H = T(p) + V(q) that we are familiar. Etienne gives a split of K [9, Forest 2006]: K = (1 + x ρ ) (1 + δ) 2 p 2 x p 2 z + b 1 (x + x2 2ρ ) b 1 (x + x2 2ρ ) ea s }{{}}{{} H 1 H 2 (62) Each part are analytically solvable for arbitrary b n 0. and Beam p Hamiltonian 0 Systems x(s) = ρ ( 1 (1 + p t) 2 p x(s) 2 p 2 y b 1 ρ dpx(s) b 1) (63) ds p x(s) = p x cos( s ρ ) + ( (1 + p t) 2 p 2 x p2 y b1(ρ + x)) sin( s ρ ) (64) y(s) = y + pys b + py (sin 1 p x ( ) sin 1 p x(s) ( )) 1ρ b 1 (1 + p t) 2 p 2 y (1 + p t) 2 p 2 y p y(s) = p y, p t(s) = p t (66) (1 + pt)s t(s) = t pt (sin 1 p x ( ) sin 1 p x(s) ( )) b 1ρ b 1 (1 + p t) 2 p 2 y (1 + p t) 2 p 2 y (67) (65) (68) 1.63 (70)

67 Transverse Beam V and Beam For straight magnet, ρ. K = T(p) + V(q). Yoshida scheme works well (70)

68 Summary I is a fundamental geometric property for Hamiltonian system that an integrator should preserve. Using differential 2-form, we can prove the symplecticness of an integrator. Symmetry may increase the order of an integrator. For most of the case, H = T(p) + V(q), composition methods are convenient. We can have an integrator up to arbitrary order (not necessary the most efficient integrator). Sector dipole, rectangular dipole and all the straight magnets can be modeled by high order integrator using the exact form of H. and Beam What about matrix code, still has any attractive advantages? Moving to integrator based tracking code? [9, Forest 2006] (70)

69 Reference I J. C. Butcher, Implicit Runge-Kutta Processes, Mathematics of Computation 18, (1964). Ronald D. Ruth, Nuclear Science, IEEE Transactions On 30, (1983). K. Feng, M. Z. Qin, The symplectic methods for the computation of Hamiltonian equations, In Y. L. Zhu and B. Y. Guo, editors, for Partial Differential Equations, Lecture Notes in Mathematics 1297, pages Springer, Berlin, J. M. Sanz-Serna, Runge-Kutta schemes for Hamiltonian systems, BIT Numerical Mathematics 28, (1988). and Beam H. Yoshida, Construction of high order symplectic integrators, Physics Letters A 150, (1990). J. M. Sanz-Serna and M. P. Calvo, Numerical Hamiltonian Problems, 1st ed. (Chapman & Hall, 1994) (70)

70 Reference II and Beam Benedict Leimkuhler and Sebastian Reich, Simulating Hamiltonian (Cambridge University Press, 2005). Ernst Hairer, Christian Lubich, and Gerhard Wanner, Geometric Numerical Integration: Structure-Preserving Algorithms for Ordinary Differential Equations, 2nd ed. (Springer, 2006). E. Forest, Geometric integration for particle accelerators, Journal of Physics A: Mathematical and General 39, (2006) (70)

71 Two-form and Beam A two-form on R 2d is a skew-symmetric bilinear function Ω(ξ, η) with arguments ξ and η. The symplectic two-form is defined as Ω(ξ, η) = ξ T Jη ξ, η R 2d (69) The geometric interpretation of the two-form Ω for d = 1 is the oriented are of the parallelogram spanned by the two vectors ξ and η. ξ T Jη = ξ 2 η 1 ξ 1 η 2, ξ = (ξ 1, ξ 2 ) T, η = (η 1, η 2 ) T For d > 1, we define Ω(ξ, η) = d Ω 0 (ξ (i), η (i) ) (70) i=1 where Ω 0 is standard two-form of a pair of vectors. Ω(ξ, η) is the sum of the oriented area of the parallelograms spanned by the pair of vectors ξ (i) and η (i) Differential 1.68 (70)

72 Examples 1 Free particle in R 3 H = p 2 /2m, (71) and Beam the flow map is ( q + t φ t,h (q, p) = m p ) p (72) 2 The pendulum. 3 Kepler s problem. H = T + V = p2 2 H = T + V = p2 1 + p2 2 2 cos(q). (73) + 1 q q 2 2 (74) 4 Modified Kepler s problem. H = T + V = p2 1 + p q q 2 2 ɛ 2 q q2 2 (75) 1.69 (70)

73 Differential k-form I and Beam ω 1 (ξ 1 ) ω 1 (ξ k ) (w 1 w k )(ξ 1,, ξ k ) = ω k (ξ 1 ) ω k (ξ k ) (76) 1.70 (70)

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

Geometric Numerical Integration

Geometric Numerical Integration Geometric Numerical Integration (Ernst Hairer, TU München, winter 2009/10) Development of numerical ordinary differential equations Nonstiff differential equations (since about 1850), see [4, 2, 1] Adams

More information

Nonlinear Single-Particle Dynamics in High Energy Accelerators

Nonlinear Single-Particle Dynamics in High Energy Accelerators Nonlinear Single-Particle Dynamics in High Energy Accelerators Part 2: Basic tools and concepts Nonlinear Single-Particle Dynamics in High Energy Accelerators This course consists of eight lectures: 1.

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

Efficiency of Runge-Kutta Methods in Solving Simple Harmonic Oscillators

Efficiency of Runge-Kutta Methods in Solving Simple Harmonic Oscillators MATEMATIKA, 8, Volume 3, Number, c Penerbit UTM Press. All rights reserved Efficiency of Runge-Kutta Methods in Solving Simple Harmonic Oscillators Annie Gorgey and Nor Azian Aini Mat Department of Mathematics,

More information

Physics 115/242 The leapfrog method and other symplectic algorithms for integrating Newton s laws of motion

Physics 115/242 The leapfrog method and other symplectic algorithms for integrating Newton s laws of motion Physics 115/242 The leapfrog method and other symplectic algorithms for integrating Newton s laws of motion Peter Young (Dated: April 17, 23) I. INTRODUCTION One frequently obtains detailed dynamical information

More information

Backward error analysis

Backward error analysis Backward error analysis Brynjulf Owren July 28, 2015 Introduction. The main source for these notes is the monograph by Hairer, Lubich and Wanner [2]. Consider ODEs in R d of the form ẏ = f(y), y(0) = y

More information

Physics 115/242 The leapfrog method and other symplectic algorithms for integrating Newton s laws of motion

Physics 115/242 The leapfrog method and other symplectic algorithms for integrating Newton s laws of motion Physics 115/242 The leapfrog method and other symplectic algorithms for integrating Newton s laws of motion Peter Young (Dated: April 14, 2009) I. INTRODUCTION One frequently obtains detailed dynamical

More information

1 Ordinary differential equations

1 Ordinary differential equations Numerical Analysis Seminar Frühjahrssemester 08 Lecturers: Prof. M. Torrilhon, Prof. D. Kressner The Störmer-Verlet method F. Crivelli (flcrivel@student.ethz.ch May 8, 2008 Introduction During this talk

More information

Lecture IV: Time Discretization

Lecture IV: Time Discretization Lecture IV: Time Discretization Motivation Kinematics: continuous motion in continuous time Computer simulation: Discrete time steps t Discrete Space (mesh particles) Updating Position Force induces acceleration.

More information

Hamiltonian flow in phase space and Liouville s theorem (Lecture 5)

Hamiltonian flow in phase space and Liouville s theorem (Lecture 5) Hamiltonian flow in phase space and Liouville s theorem (Lecture 5) January 26, 2016 90/441 Lecture outline We will discuss the Hamiltonian flow in the phase space. This flow represents a time dependent

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

Estimating Accuracy in Classical Molecular Simulation

Estimating Accuracy in Classical Molecular Simulation Estimating Accuracy in Classical Molecular Simulation University of Illinois Urbana-Champaign Department of Computer Science Institute for Mathematics and its Applications July 2007 Acknowledgements Ben

More information

Non-linear dynamics! in particle accelerators!

Non-linear dynamics! in particle accelerators! Non-linear dynamics! in particle accelerators! Yannis PAPAPHILIPPOU Accelerator and Beam Physics group Beams Department CERN" Cockroft Institute Lecture Courses Daresbury, UK 16-19 September 2013 1! Contents

More information

Symplectic integration with Runge-Kutta methods, AARMS summer school 2015

Symplectic integration with Runge-Kutta methods, AARMS summer school 2015 Symplectic integration with Runge-Kutta methods, AARMS summer school 2015 Elena Celledoni July 13, 2015 1 Hamiltonian systems and their properties We consider a Hamiltonian system in the form ẏ = J H(y)

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

THEWAY in which time evolution acts on observables may be rephrased in

THEWAY in which time evolution acts on observables may be rephrased in Appendix F Implementing evolution F.1 Koopmania THEWAY in which time evolution acts on observables may be rephrased in the language of functional analysis, by introducing the Koopman operator, whose action

More information

Physics 106a, Caltech 13 November, Lecture 13: Action, Hamilton-Jacobi Theory. Action-Angle Variables

Physics 106a, Caltech 13 November, Lecture 13: Action, Hamilton-Jacobi Theory. Action-Angle Variables Physics 06a, Caltech 3 November, 08 Lecture 3: Action, Hamilton-Jacobi Theory Starred sections are advanced topics for interest and future reference. The unstarred material will not be tested on the final

More information

SYMMETRIC PROJECTION METHODS FOR DIFFERENTIAL EQUATIONS ON MANIFOLDS

SYMMETRIC PROJECTION METHODS FOR DIFFERENTIAL EQUATIONS ON MANIFOLDS BIT 0006-3835/00/4004-0726 $15.00 2000, Vol. 40, No. 4, pp. 726 734 c Swets & Zeitlinger SYMMETRIC PROJECTION METHODS FOR DIFFERENTIAL EQUATIONS ON MANIFOLDS E. HAIRER Section de mathématiques, Université

More information

Introduction to numerical methods for Ordinary Differential Equations

Introduction to numerical methods for Ordinary Differential Equations Introduction to numerical methods for Ordinary Differential Equations Charles-Edouard Bréhier Abstract The aims of these lecture notes are the following. We introduce Euler numerical schemes, and prove

More information

RUNGE-KUTTA SCHEMES FOR HAMILTONIAN SYSTEMS

RUNGE-KUTTA SCHEMES FOR HAMILTONIAN SYSTEMS BIT28 (1988),877-8.83 RUNGE-KUTTA SCHEMES FOR HAMILTONIAN SYSTEMS J. M. SANZ-SERNA Departamento de Materndtica Apiicada y Computaci6n, Facuttad de Ciencias, Universidad de Valladolid, Valladolid, Spain

More information

SOLVING ODE s NUMERICALLY WHILE PRESERVING ALL FIRST INTEGRALS

SOLVING ODE s NUMERICALLY WHILE PRESERVING ALL FIRST INTEGRALS SOLVING ODE s NUMERICALLY WHILE PRESERVING ALL FIRST INTEGRALS G.R.W. QUISPEL 1,2 and H.W. CAPEL 3 Abstract. Using Discrete Gradient Methods (Quispel & Turner, J. Phys. A29 (1996) L341-L349) we construct

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

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

Three Loose Ends: Edge Focusing; Chromaticity; Beam Rigidity.

Three Loose Ends: Edge Focusing; Chromaticity; Beam Rigidity. Linear Dynamics, Lecture 5 Three Loose Ends: Edge Focusing; Chromaticity; Beam Rigidity. Andy Wolski University of Liverpool, and the Cockcroft Institute, Daresbury, UK. November, 2012 What we Learned

More information

E. Wilson - CERN. Components of a synchrotron. Dipole Bending Magnet. Magnetic rigidity. Bending Magnet. Weak focusing - gutter. Transverse ellipse

E. Wilson - CERN. Components of a synchrotron. Dipole Bending Magnet. Magnetic rigidity. Bending Magnet. Weak focusing - gutter. Transverse ellipse Transverse Dynamics E. Wilson - CERN Components of a synchrotron Dipole Bending Magnet Magnetic rigidity Bending Magnet Weak focusing - gutter Transverse ellipse Fields and force in a quadrupole Strong

More information

Physics 106b: Lecture 7 25 January, 2018

Physics 106b: Lecture 7 25 January, 2018 Physics 106b: Lecture 7 25 January, 2018 Hamiltonian Chaos: Introduction Integrable Systems We start with systems that do not exhibit chaos, but instead have simple periodic motion (like the SHO) with

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

arxiv: v1 [physics.plasm-ph] 15 Sep 2013

arxiv: v1 [physics.plasm-ph] 15 Sep 2013 Symplectic Integration of Magnetic Systems arxiv:309.373v [physics.plasm-ph] 5 Sep 03 Abstract Stephen D. Webb Tech-X Corporation, 56 Arapahoe Ave., Boulder, CO 80303 Dependable numerical results from

More information

Equations of motion in an accelerator (Lecture 7)

Equations of motion in an accelerator (Lecture 7) Equations of motion in an accelerator (Lecture 7) January 27, 2016 130/441 Lecture outline We consider several types of magnets used in accelerators and write down the vector potential of the magnetic

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

THE Hamilton equations of motion constitute a system

THE Hamilton equations of motion constitute a system Proceedings of the World Congress on Engineering 0 Vol I WCE 0, July 4-6, 0, London, U.K. Systematic Improvement of Splitting Methods for the Hamilton Equations Asif Mushtaq, Anne Kværnø, and Kåre Olaussen

More information

Introduction to standard and non-standard Numerical Methods

Introduction to standard and non-standard Numerical Methods Introduction to standard and non-standard Numerical Methods Dr. Mountaga LAM AMS : African Mathematic School 2018 May 23, 2018 One-step methods Runge-Kutta Methods Nonstandard Finite Difference Scheme

More information

Symplectic Runge-Kutta methods satisfying effective order conditions

Symplectic Runge-Kutta methods satisfying effective order conditions /30 Symplectic Runge-Kutta methods satisfying effective order conditions Gulshad Imran John Butcher (supervisor) University of Auckland 5 July, 20 International Conference on Scientific Computation and

More information

Lecture V: The game-engine loop & Time Integration

Lecture V: The game-engine loop & Time Integration Lecture V: The game-engine loop & Time Integration The Basic Game-Engine Loop Previous state: " #, %(#) ( #, )(#) Forces -(#) Integrate velocities and positions Resolve Interpenetrations Per-body change

More information

THEODORE VORONOV DIFFERENTIABLE MANIFOLDS. Fall Last updated: November 26, (Under construction.)

THEODORE VORONOV DIFFERENTIABLE MANIFOLDS. Fall Last updated: November 26, (Under construction.) 4 Vector fields Last updated: November 26, 2009. (Under construction.) 4.1 Tangent vectors as derivations After we have introduced topological notions, we can come back to analysis on manifolds. Let M

More information

Fourth Order RK-Method

Fourth Order RK-Method Fourth Order RK-Method The most commonly used method is Runge-Kutta fourth order method. The fourth order RK-method is y i+1 = y i + 1 6 (k 1 + 2k 2 + 2k 3 + k 4 ), Ordinary Differential Equations (ODE)

More information

Time-Dependent Statistical Mechanics 5. The classical atomic fluid, classical mechanics, and classical equilibrium statistical mechanics

Time-Dependent Statistical Mechanics 5. The classical atomic fluid, classical mechanics, and classical equilibrium statistical mechanics Time-Dependent Statistical Mechanics 5. The classical atomic fluid, classical mechanics, and classical equilibrium statistical mechanics c Hans C. Andersen October 1, 2009 While we know that in principle

More information

Draft TAYLOR SERIES METHOD FOR SYSTEM OF PARTICLES INTERACTING VIA LENNARD-JONES POTENTIAL. Nikolai Shegunov, Ivan Hristov

Draft TAYLOR SERIES METHOD FOR SYSTEM OF PARTICLES INTERACTING VIA LENNARD-JONES POTENTIAL. Nikolai Shegunov, Ivan Hristov TAYLOR SERIES METHOD FOR SYSTEM OF PARTICLES INTERACTING VIA LENNARD-JONES POTENTIAL Nikolai Shegunov, Ivan Hristov March 9, Seminar in IMI,BAS,Soa 1/25 Mathematical model We consider the Hamiltonian :

More information

Reducing round-off errors in symmetric multistep methods

Reducing round-off errors in symmetric multistep methods Reducing round-off errors in symmetric multistep methods Paola Console a, Ernst Hairer a a Section de Mathématiques, Université de Genève, 2-4 rue du Lièvre, CH-1211 Genève 4, Switzerland. (Paola.Console@unige.ch,

More information

Geometric methods for orbit integration. PiTP 2009 Scott Tremaine

Geometric methods for orbit integration. PiTP 2009 Scott Tremaine Geometric methods for orbit integration PiTP 2009 Scott Tremaine spacecraft trajectories Cassini-Huygens trajectory around Saturn, 2004-2008 Planetary orbits lines = current orbits of the four inner planets

More information

Variable Step Runge-Kutta-Nyström Methods for the Numerical Solution of Reversible Systems

Variable Step Runge-Kutta-Nyström Methods for the Numerical Solution of Reversible Systems Variable Step Runge-Kutta-Nyström Methods for the Numerical Solution of Reversible Systems J. R. Cash and S. Girdlestone Department of Mathematics, Imperial College London South Kensington London SW7 2AZ,

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

SYMMETRIC AND SYMPLECTIC METHODS FOR GYROCENTER DYNAMICS IN TIME-INDEPENDENT MAGNETIC FIELDS

SYMMETRIC AND SYMPLECTIC METHODS FOR GYROCENTER DYNAMICS IN TIME-INDEPENDENT MAGNETIC FIELDS SMMETRIC AND SMPLECTIC METHODS FOR GROCENTER DNAMICS IN TIME-INDEPENDENT MAGNETIC FIELDS by Beibei Zhu, Zhenxuan Hu, ifa Tang and Ruili Zhang Report No. ICMSEC-5-3 November 25 Research Report Institute

More information

Symplectic Maps for General Hamiltonians

Symplectic Maps for General Hamiltonians Symplectic Maps for General Hamiltonians Malte Titze November 2, 2015 Outline 1 Introduction 2 Canonical Transformations 3 Obtaining the Map M. Titze (CERN / University of Berlin) Symplectic Maps for General

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

2 Canonical quantization

2 Canonical quantization Phys540.nb 7 Canonical quantization.1. Lagrangian mechanics and canonical quantization Q: How do we quantize a general system?.1.1.lagrangian Lagrangian mechanics is a reformulation of classical mechanics.

More information

Geometric Gyrokinetic Theory and its Applications to Large-Scale Simulations of Magnetized Plasmas

Geometric Gyrokinetic Theory and its Applications to Large-Scale Simulations of Magnetized Plasmas Geometric Gyrokinetic Theory and its Applications to Large-Scale Simulations of Magnetized Plasmas Hong Qin Princeton Plasma Physics Laboratory, Princeton University CEA-EDF-INRIA School -- Numerical models

More information

Parallel-in-time integrators for Hamiltonian systems

Parallel-in-time integrators for Hamiltonian systems Parallel-in-time integrators for Hamiltonian systems Claude Le Bris ENPC and INRIA Visiting Professor, The University of Chicago joint work with X. Dai (Paris 6 and Chinese Academy of Sciences), F. Legoll

More information

Fourth-order symplectic exponentially-fitted modified Runge-Kutta methods of the Gauss type: a review

Fourth-order symplectic exponentially-fitted modified Runge-Kutta methods of the Gauss type: a review Fourth-order symplectic exponentially-fitted modified Runge-Kutta methods of the Gauss type: a review G. Vanden Berghe and M. Van Daele Vakgroep Toegepaste Wiskunde en Informatica, Universiteit Gent, Krijgslaan

More information

The Koopmanoperator action on a state space function a(x) is to replace it by

The Koopmanoperator action on a state space function a(x) is to replace it by Appendix A9 Implementing evolution A9. Koopmania The Koopmanoperator action on a state space function a(x) is to replace it by its downstream value time t later, a(x) a(x(t)), evaluated at the trajectory

More information

Homework 4. Goldstein 9.7. Part (a) Theoretical Dynamics October 01, 2010 (1) P i = F 1. Q i. p i = F 1 (3) q i (5) P i (6)

Homework 4. Goldstein 9.7. Part (a) Theoretical Dynamics October 01, 2010 (1) P i = F 1. Q i. p i = F 1 (3) q i (5) P i (6) Theoretical Dynamics October 01, 2010 Instructor: Dr. Thomas Cohen Homework 4 Submitted by: Vivek Saxena Goldstein 9.7 Part (a) F 1 (q, Q, t) F 2 (q, P, t) P i F 1 Q i (1) F 2 (q, P, t) F 1 (q, Q, t) +

More information

WORD SERIES FOR THE ANALYSIS OF SPLITTING SDE INTEGRATORS. Alfonso Álamo/J. M. Sanz-Serna Universidad de Valladolid/Universidad Carlos III de Madrid

WORD SERIES FOR THE ANALYSIS OF SPLITTING SDE INTEGRATORS. Alfonso Álamo/J. M. Sanz-Serna Universidad de Valladolid/Universidad Carlos III de Madrid WORD SERIES FOR THE ANALYSIS OF SPLITTING SDE INTEGRATORS Alfonso Álamo/J. M. Sanz-Serna Universidad de Valladolid/Universidad Carlos III de Madrid 1 I. OVERVIEW 2 The importance of splitting integrators

More information

Accelerator Physics Homework #3 P470 (Problems: 1-5)

Accelerator Physics Homework #3 P470 (Problems: 1-5) Accelerator Physics Homework #3 P470 (Problems: -5). Particle motion in the presence of magnetic field errors is (Sect. II.2) y + K(s)y = B Bρ, where y stands for either x or z. Here B = B z for x motion,

More information

The Accelerator Hamiltonian in a Straight Coordinate System

The Accelerator Hamiltonian in a Straight Coordinate System Hamiltoninan Dynamics for Particle Accelerators, Lecture 2 The Accelerator Hamiltonian in a Straight Coordinate System Andy Wolski University of Liverpool, and the Cockcroft Institute, Daresbury, UK. Given

More information

SOME PROPERTIES OF SYMPLECTIC RUNGE-KUTTA METHODS

SOME PROPERTIES OF SYMPLECTIC RUNGE-KUTTA METHODS SOME PROPERTIES OF SYMPLECTIC RUNGE-KUTTA METHODS ERNST HAIRER AND PIERRE LEONE Abstract. We prove that to every rational function R(z) satisfying R( z)r(z) = 1, there exists a symplectic Runge-Kutta method

More information

CERN Accelerator School. Intermediate Accelerator Physics Course Chios, Greece, September Low Emittance Rings

CERN Accelerator School. Intermediate Accelerator Physics Course Chios, Greece, September Low Emittance Rings CERN Accelerator School Intermediate Accelerator Physics Course Chios, Greece, September 2011 Low Emittance Rings Part 1: Beam Dynamics with Synchrotron Radiation Andy Wolski The Cockcroft Institute, and

More information

Physics 115/242 Comparison of methods for integrating the simple harmonic oscillator.

Physics 115/242 Comparison of methods for integrating the simple harmonic oscillator. Physics 115/4 Comparison of methods for integrating the simple harmonic oscillator. Peter Young I. THE SIMPLE HARMONIC OSCILLATOR The energy (sometimes called the Hamiltonian ) of the simple harmonic oscillator

More information

Runga-Kutta Schemes. Exact evolution over a small time step: Expand both sides in a small time increment: d(δt) F (x(t + δt),t+ δt) Ft + FF x ( t)

Runga-Kutta Schemes. Exact evolution over a small time step: Expand both sides in a small time increment: d(δt) F (x(t + δt),t+ δt) Ft + FF x ( t) Runga-Kutta Schemes Exact evolution over a small time step: x(t + t) =x(t)+ t 0 d(δt) F (x(t + δt),t+ δt) Expand both sides in a small time increment: x(t + t) =x(t)+x (t) t + 1 2 x (t)( t) 2 + 1 6 x (t)+

More information

Definition 5.1. A vector field v on a manifold M is map M T M such that for all x M, v(x) T x M.

Definition 5.1. A vector field v on a manifold M is map M T M such that for all x M, v(x) T x M. 5 Vector fields Last updated: March 12, 2012. 5.1 Definition and general properties We first need to define what a vector field is. Definition 5.1. A vector field v on a manifold M is map M T M such that

More information

Transverse Dynamics II

Transverse Dynamics II Transverse Dynamics II JAI Accelerator Physics Course Michaelmas Term 217 Dr. Suzie Sheehy Royal Society University Research Fellow University of Oxford Acknowledgements These lectures have been produced

More information

Second quantization: where quantization and particles come from?

Second quantization: where quantization and particles come from? 110 Phys460.nb 7 Second quantization: where quantization and particles come from? 7.1. Lagrangian mechanics and canonical quantization Q: How do we quantize a general system? 7.1.1.Lagrangian Lagrangian

More information

Hamiltonian Dynamics

Hamiltonian Dynamics Hamiltonian Dynamics CDS 140b Joris Vankerschaver jv@caltech.edu CDS Feb. 10, 2009 Joris Vankerschaver (CDS) Hamiltonian Dynamics Feb. 10, 2009 1 / 31 Outline 1. Introductory concepts; 2. Poisson brackets;

More information

Lecture 4: Numerical solution of ordinary differential equations

Lecture 4: Numerical solution of ordinary differential equations Lecture 4: Numerical solution of ordinary differential equations Department of Mathematics, ETH Zürich General explicit one-step method: Consistency; Stability; Convergence. High-order methods: Taylor

More information

The kinetic equation (Lecture 11)

The kinetic equation (Lecture 11) The kinetic equation (Lecture 11) January 29, 2016 190/441 Lecture outline In the preceding lectures we focused our attention on a single particle motion. In this lecture, we will introduce formalism for

More information

Particle Accelerators: Transverse Beam Dynamics

Particle Accelerators: Transverse Beam Dynamics Particle Accelerators: Transverse Beam Dynamics Volker Ziemann Department of Physics and Astronomy Uppsala University Research Training course in Detector Technology Stockholm, Sept. 8, 2008 080908 V.

More information

Introduction to the Numerical Solution of IVP for ODE

Introduction to the Numerical Solution of IVP for ODE Introduction to the Numerical Solution of IVP for ODE 45 Introduction to the Numerical Solution of IVP for ODE Consider the IVP: DE x = f(t, x), IC x(a) = x a. For simplicity, we will assume here that

More information

Ernst Hairer 1, Robert I. McLachlan 2 and Robert D. Skeel 3

Ernst Hairer 1, Robert I. McLachlan 2 and Robert D. Skeel 3 Mathematical Modelling and Numerical Analysis Modélisation Mathématique et Analyse Numérique Will be set by the publisher ON ENERGY CONSERVATION OF THE SIMPLIFIED TAKAHASHI IMADA METHOD, Ernst Hairer 1,

More information

ME 680- Spring Representation and Stability Concepts

ME 680- Spring Representation and Stability Concepts ME 680- Spring 014 Representation and Stability Concepts 1 3. Representation and stability concepts 3.1 Continuous time systems: Consider systems of the form x F(x), x n (1) where F : U Vis a mapping U,V

More information

Review Higher Order methods Multistep methods Summary HIGHER ORDER METHODS. P.V. Johnson. School of Mathematics. Semester

Review Higher Order methods Multistep methods Summary HIGHER ORDER METHODS. P.V. Johnson. School of Mathematics. Semester HIGHER ORDER METHODS School of Mathematics Semester 1 2008 OUTLINE 1 REVIEW 2 HIGHER ORDER METHODS 3 MULTISTEP METHODS 4 SUMMARY OUTLINE 1 REVIEW 2 HIGHER ORDER METHODS 3 MULTISTEP METHODS 4 SUMMARY OUTLINE

More information

Poisson Brackets and Lie Operators

Poisson Brackets and Lie Operators Poisson Brackets and Lie Operators T. Satogata January 22, 2008 1 Symplecticity and Poisson Brackets 1.1 Symplecticity Consider an n-dimensional 2n-dimensional phase space) linear system. Let the canonical

More information

The Kepler Problem and the Isotropic Harmonic Oscillator. M. K. Fung

The Kepler Problem and the Isotropic Harmonic Oscillator. M. K. Fung CHINESE JOURNAL OF PHYSICS VOL. 50, NO. 5 October 01 The Kepler Problem and the Isotropic Harmonic Oscillator M. K. Fung Department of Physics, National Taiwan Normal University, Taipei, Taiwan 116, R.O.C.

More information

Hamiltonian Dynamics In The Theory of Abstraction

Hamiltonian Dynamics In The Theory of Abstraction Hamiltonian Dynamics In The Theory of Abstraction Subhajit Ganguly. email: gangulysubhajit@indiatimes.com Abstract: This paper deals with fluid flow dynamics which may be Hamiltonian in nature and yet

More information

Xiaobiao Huang Accelerator Physics August 28, The Dipole Passmethod for Accelerator Toolbox

Xiaobiao Huang Accelerator Physics August 28, The Dipole Passmethod for Accelerator Toolbox STANFORD SYNCHROTRON RADIATION LABORATORY Accelerator Physics Note CODE SERIAL PAGE 021 8 AUTHOR GROUP DATE/REVISION Xiaobiao Huang Accelerator Physics August 28, 2009 TITLE The Dipole Passmethod for Accelerator

More information

Low Emittance Machines

Low Emittance Machines CERN Accelerator School Advanced Accelerator Physics Course Trondheim, Norway, August 2013 Low Emittance Machines Part 1: Beam Dynamics with Synchrotron Radiation Andy Wolski The Cockcroft Institute, 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

TWISS FUNCTIONS. Lecture 1 January P.J. Bryant. JUAS18_01- P.J. Bryant - Lecture 1 Twiss functions

TWISS FUNCTIONS. Lecture 1 January P.J. Bryant. JUAS18_01- P.J. Bryant - Lecture 1 Twiss functions TWISS FUNCTIONS Lecture January 08 P.J. Bryant JUAS8_0- P.J. Bryant - Lecture Slide Introduction These lectures assume knowledge of : The nd order differential equations of motion in hard-edge field models

More information

Physics 209 Fall 2002 Notes 5 Thomas Precession

Physics 209 Fall 2002 Notes 5 Thomas Precession Physics 209 Fall 2002 Notes 5 Thomas Precession Jackson s discussion of Thomas precession is based on Thomas s original treatment, and on the later paper by Bargmann, Michel, and Telegdi. The alternative

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

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

Orbital Motion in Schwarzschild Geometry

Orbital Motion in Schwarzschild Geometry Physics 4 Lecture 29 Orbital Motion in Schwarzschild Geometry Lecture 29 Physics 4 Classical Mechanics II November 9th, 2007 We have seen, through the study of the weak field solutions of Einstein s equation

More information

High-Order Representation of Poincaré Maps

High-Order Representation of Poincaré Maps High-Order Representation of Poincaré Maps Johannes Grote, Martin Berz, and Kyoko Makino Department of Physics and Astronomy, Michigan State University, East Lansing, MI, USA. {grotejoh,berz,makino}@msu.edu

More information

Introduction to Computer Graphics (Lecture No 07) Ellipse and Other Curves

Introduction to Computer Graphics (Lecture No 07) Ellipse and Other Curves Introduction to Computer Graphics (Lecture No 07) Ellipse and Other Curves 7.1 Ellipse An ellipse is a curve that is the locus of all points in the plane the sum of whose distances r1 and r from two fixed

More information

Introduction to Applied Nonlinear Dynamical Systems and Chaos

Introduction to Applied Nonlinear Dynamical Systems and Chaos Stephen Wiggins Introduction to Applied Nonlinear Dynamical Systems and Chaos Second Edition With 250 Figures 4jj Springer I Series Preface v L I Preface to the Second Edition vii Introduction 1 1 Equilibrium

More information

Ordinary Differential Equations II

Ordinary Differential Equations II Ordinary Differential Equations II CS 205A: Mathematical Methods for Robotics, Vision, and Graphics Justin Solomon CS 205A: Mathematical Methods Ordinary Differential Equations II 1 / 33 Almost Done! Last

More information

Computational Techniques Prof. Dr. Niket Kaisare Department of Chemical Engineering Indian Institute of Technology, Madras

Computational Techniques Prof. Dr. Niket Kaisare Department of Chemical Engineering Indian Institute of Technology, Madras Computational Techniques Prof. Dr. Niket Kaisare Department of Chemical Engineering Indian Institute of Technology, Madras Module No. # 07 Lecture No. # 04 Ordinary Differential Equations (Initial Value

More information

Ordinary Differential Equations (ODEs)

Ordinary Differential Equations (ODEs) Ordinary Differential Equations (ODEs) 1 Computer Simulations Why is computation becoming so important in physics? One reason is that most of our analytical tools such as differential calculus are best

More information

Use conserved quantities to reduce number of variables and the equation of motion (EOM)

Use conserved quantities to reduce number of variables and the equation of motion (EOM) Physics 106a, Caltech 5 October, 018 Lecture 8: Central Forces Bound States Today we discuss the Kepler problem of the orbital motion of planets and other objects in the gravitational field of the sun.

More information

Introduction to symplectic integrator methods for solving diverse dynamical equations

Introduction to symplectic integrator methods for solving diverse dynamical equations Introduction to symplectic integrator methods for solving diverse dynamical equations Siu A. Chin Department of Physics and Astronomy Texas A&M University College Station, TX, 77840, USA Third Lecture

More information

Quantum Theory and Group Representations

Quantum Theory and Group Representations Quantum Theory and Group Representations Peter Woit Columbia University LaGuardia Community College, November 1, 2017 Queensborough Community College, November 15, 2017 Peter Woit (Columbia University)

More information

QUATERNIONS AND ROTATIONS

QUATERNIONS AND ROTATIONS QUATERNIONS AND ROTATIONS SVANTE JANSON 1. Introduction The purpose of this note is to show some well-known relations between quaternions and the Lie groups SO(3) and SO(4) (rotations in R 3 and R 4 )

More information

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

Generators for Continuous Coordinate Transformations

Generators for Continuous Coordinate Transformations Page 636 Lecture 37: Coordinate Transformations: Continuous Passive Coordinate Transformations Active Coordinate Transformations Date Revised: 2009/01/28 Date Given: 2009/01/26 Generators for Continuous

More information

Under evolution for a small time δt the area A(t) = q p evolves into an area

Under evolution for a small time δt the area A(t) = q p evolves into an area Physics 106a, Caltech 6 November, 2018 Lecture 11: Hamiltonian Mechanics II Towards statistical mechanics Phase space volumes are conserved by Hamiltonian dynamics We can use many nearby initial conditions

More information

Symplectic exponentially-fitted modified Runge-Kutta methods of the Gauss type: revisited

Symplectic exponentially-fitted modified Runge-Kutta methods of the Gauss type: revisited Symplectic exponentially-fitted modified Runge-Kutta methods of the Gauss type: revisited G. Vanden Berghe and M. Van Daele Vakgroep Toegepaste Wiskunde en Informatica, Universiteit Gent, Krijgslaan 8

More information

PHY411 Lecture notes Part 2

PHY411 Lecture notes Part 2 PHY411 Lecture notes Part 2 Alice Quillen April 6, 2017 Contents 1 Canonical Transformations 2 1.1 Poisson Brackets................................. 2 1.2 Canonical transformations............................

More information

Symplectic maps. James D. Meiss. March 4, 2008

Symplectic maps. James D. Meiss. March 4, 2008 Symplectic maps James D. Meiss March 4, 2008 First used mathematically by Hermann Weyl, the term symplectic arises from a Greek word that means twining or plaiting together. This is apt, as symplectic

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

The Big Picture. Python environment? Discuss Examples of unpredictability. Chaos, Scientific American (1986)

The Big Picture. Python environment? Discuss Examples of unpredictability. Chaos, Scientific American (1986) The Big Picture Python environment? Discuss Examples of unpredictability Email homework to me: chaos@cse.ucdavis.edu Chaos, Scientific American (1986) Odds, Stanislaw Lem, The New Yorker (1974) 1 Nonlinear

More information

NOTES ON DIFFERENTIAL FORMS. PART 1: FORMS ON R n

NOTES ON DIFFERENTIAL FORMS. PART 1: FORMS ON R n NOTES ON DIFFERENTIAL FORMS. PART 1: FORMS ON R n 1. What is a form? Since we re not following the development in Guillemin and Pollack, I d better write up an alternate approach. In this approach, we

More information