From Particle Accelerators to Celestial Dynamics: An Introduction to Differential Algebra

Size: px
Start display at page:

Download "From Particle Accelerators to Celestial Dynamics: An Introduction to Differential Algebra"

Transcription

1 AstroNet II Summer School 2014 Friday, 27 June 2014 Zielona Góra (Poland) From Particle Accelerators to Celestial Dynamics: An Introduction to Differential Algebra 1, Pierluigi di Lizia 1, Roberto Armellin 2 1 Dipartimento Scienze e Tecnologie Aerospaziali, Politecnico di Milano 2 School of Engineering Sciences, University of Southampton 27 June 2014, Zielona Góra (Poland) Introduction to DA 0/56

2 Outline 1 What is Differential Algebra? 1 Introduction 2 History 2 Six Views of Differential Algebra 1 Multivariate Polynomials 2 Automatic Differentiation 3 Functional Analysis 4 Non-Archimedean Analysis 5 Set Theory 6 Symbolic Computation 3 Differential Algebra Algorithms 4 Applications in Aerospace Engineering 27 June 2014, Zielona Góra (Poland) Introduction to DA 1/56

3 What is Differential Algebra Multivariate Polynomials Non-Archimedean Analysis Automatic Differentiation Differential Algebra Set Theory Functional Analysis Symbolic Computation 27 June 2014, Zielona Góra (Poland) Introduction to DA 2/56

4 Overview Differential Algebra A general numerical technique based on the efficient implementation of polynomials with applications in many different fields. Aspects of what we call Differential Algebra is known under various other names: Truncated Polynomial Series Algebra (TPSA) Automatic forward differentiation Jet Transport (for flow expansion) 27 June 2014, Zielona Góra (Poland) Introduction to DA 3/56

5 History of Differential Algebra Differential Algebra Techniques Introduced in Beam Physics (Berz, 1987) Computation of transfer maps in particle optics Extended to Rigorous Numerics (Makino & Berz, 1996) Rigorous numerical treatment including truncation and round-off errors for computer assisted proofs Wide range of applications to Celestial Mechanics (Lizia et al., 2007) Uncertainty propagation, Two-Point Boundary Value Problem, Optimal Control, June 2014, Zielona Góra (Poland) Introduction to DA 4/56

6 Beam & Accelerator Physics 27 June 2014, Zielona Góra (Poland) Introduction to DA 5/56

7 Beam & Accelerator Physics Simulation of repetitive particle optical systems: Complicated dynamical system: Goals: Thousands of magnetic and/or electrostatic elements Complicated field profiles Symplectic motion Small time scales (50, 000 revolutions per second) Design parameter optimization Long term stability properties Avoidance of chaotic motion 27 June 2014, Zielona Góra (Poland) Introduction to DA 6/56

8 Beam & Accelerator Physics Mathematical Tools Transfer Maps (Poincaré section) Symplectic Tracking (Iteration & Visualization) Periodic Points, Invariant Manifolds (Phase Space Structure Determination) Normal Form Transformation, Normal Form Defect Function Numerical Tool: Differential Algebra: powerful numerical method to compute and analyze high order polynomial transfer maps.(berz, 1999) 27 June 2014, Zielona Góra (Poland) Introduction to DA 7/56

9 Beam & Accelerator Physics I COEFFICIENT ORDER EXPONENTS E E E E E E E E E E E Partial Tevatron 18 transfer E-15 map ( 2000 coefficients 3 2 / 0 coordinate 0 1 in 4 coordinates) E E June 2014, Zielona Góra (Poland) Introduction to DA 8/56

10 Beam & Accelerator Physics x-a tracking picture of Tevatron transfer map 27 June 2014, Zielona Góra (Poland) Introduction to DA 9/56

11 Beam & Accelerator Physics Typical main task: Compute Poincare section of beam line pointwise: slow, hard to analyze resulting (image) data analytical: difficult and time consuming, previously done to orders 4 or 5 only DA: arbitrary order expansion of Poincaré map as polynomial (easy to analyze, fast to evaluate, fast to code) 27 June 2014, Zielona Góra (Poland) Introduction to DA 10/56

12 DA in Astrodynamics In 2006, Pierluigi di Lizia and Roberto Armellin from Politecnico di Milano visited MSU to study DA. They introduced the technique in the field and have applied it to various problems: Uncertainty propagation TPBVP in astrodynamics Orbit Determination MOID and collision probability computation Robust optimal control of space trajectories Global optimization of interplanetary transfers 27 June 2014, Zielona Góra (Poland) Introduction to DA 11/56

13 Differential Algebra A numerical technique to automatically compute high order Taylor expansions of functions f ( x 0 + δx) f ( x 0 ) + f ( x 0 ) δx n! f (n) ( x 0 ) δx n Can be conceptualized in various ways from different view points: Multivariate Polynomials Functional Analysis Set Theory Symbolic Computation Automatic Differentiation Non-Archimedean Analysis 27 June 2014, Zielona Góra (Poland) Introduction to DA 12/56

14 as an Algebra of Truncated Multivariate Polynomials Multivariate Polynomials Automatic Differentiation Functional Analysis Non-Archimedean Analysis Differential Algebra Set Theory Symbolic Computation 27 June 2014, Zielona Góra (Poland) Introduction to DA 13/56

15 as an Algebra of Truncated Multivariate Polynomials Motivation: ( ) sin(x) cos(y) + 1 f (x, y, z) = exp 1 + x 2 + y 2 + z 2 mathematical expression: instructions of operations to be performed x, y, z can be various things: real number (R), complex number (C), sometimes matrices (R n n ),... all operations must be defined in a useful way Goal Replace all algebraic operations between numbers by ones that act on (a suitably chosen subset of) polynomials instead. 27 June 2014, Zielona Góra (Poland) Introduction to DA 14/56

16 as an Algebra of Truncated Multivariate Polynomials 1 Ring of polynomials Natural Addition, Subtraction, Multiplication of polynomials Problems: order of polynomials not limited, grows under multiplication infinite dimensional not suited for computations 27 June 2014, Zielona Góra (Poland) Introduction to DA 15/56

17 as an Algebra of Truncated Multivariate Polynomials 1 Ring of polynomials Natural Addition, Subtraction, Multiplication of polynomials Problems: order of polynomials not limited, grows under multiplication infinite dimensional not suited for computations 2 Algebra of truncated polynomials Truncate all results to a fixed order n Finite dimensional space, hence computable Space n D v of polynomials of order up to n in v variables (n+v)! n!v! dimensions Not a ring or field: e.g. many nil-potent elements x, x x 2, June 2014, Zielona Góra (Poland) Introduction to DA 15/56

18 as an Algebra of Truncated Multivariate Polynomials Now we have +,,. Let s add division (i.e. multiplicative inverse): 1 That is: P nd v such that P 1 P = 1 Does not always exist: P(x) = x and Q(x) = (q 0 + q 1 x + q 2 x q n x n ) P(x) Q(x) = x (q 0 + q 1 x + q 2 x q n x n ) = q 0 x + q 1 x q n 1 x n +q n x n+1 No constant part for any coefficients q i Exists iff P(x) = C + N(x) satisfies C 0 and N(0) = 0 in n D v n D v not a field Does not exist in ring of polynomials! 27 June 2014, Zielona Góra (Poland) Introduction to DA 16/56

19 as an Algebra of Truncated Multivariate Polynomials Multiplicative inverse of P(x) = C + N(x). 1 1 Calculating multiplicative inverse P(x) using naive power series expansion δx = 1 δx + δx 2 δx with δx = P(x) 1. Bad: how many terms needed for convergence? 27 June 2014, Zielona Góra (Poland) Introduction to DA 17/56

20 as an Algebra of Truncated Multivariate Polynomials Multiplicative inverse of P(x) = C + N(x). 1 1 Calculating multiplicative inverse P(x) using naive power series expansion δx = 1 δx + δx 2 δx with δx = P(x) 1. Bad: how many terms needed for convergence? 2 Instead, use smarter power series expansion with δx = N(x). 1 C + δx = 1 C δx C 2 + δx 2 C 3 δx 3 C Non-constant part N(x) is nilpotent, i.e. N n+1 = 0 Only finitely many (n) terms of series needed 27 June 2014, Zielona Góra (Poland) Introduction to DA 17/56

21 as an Algebra of Truncated Multivariate Polynomials Now we have +,,, /. Let s add intrinsic functions (e.g., sin, cos, exp,...) 1 Taylor expansion around constant part Square root: 1 δx C + δx = C + 1 δx 2 2 C C computed using similar arguments as for division 2 Mathematical identities to reduce problem exp(c + N(x)) = exp(c) exp(n(x)) exp(c) only for constant part (a number) exp(n(x)) only for non-linear part, hence converges after n terms 27 June 2014, Zielona Góra (Poland) Introduction to DA 18/56

22 as an Algebra of Truncated Multivariate Polynomials We now have +,,, /, intrinsic functions (e.g., sin, cos, exp,...). Almost there: can evaluate any function f given as a finite combination of these arithmetic operations and intrinsic functions in DA: ( ) sin(x) cos(y) + 1 f (x, y, z) = exp 1 + x 2 + y 2 + z 2 Result: (Taylor) polynomial P(x, y, z) of f (x, y, z) to arbitrary order. 27 June 2014, Zielona Góra (Poland) Introduction to DA 19/56

23 as an Algebra of Truncated Multivariate Polynomials Last thing: Add derivation and inverse derivation 1 operators to obtain differential algebra. x : Simple polynomial derivation w.r.t. independent variable x a 0 + a 1 x + a 2 x 2 + a 1 + a 2 x + x 1 : Simple polynomial integration w.r.t. independent variable x a 0 + a 1 x + a 2 x a 0 x + a 1 x 2 + a 2 x 3 Now we can evaluate even complicated operators directly in DA: ˆ ˆ ( ) d g(x, y, z) = dy exp sin(x) cos(y) + 1 dx dz 1 + x 2 + y 2 + z 2 Result: (Taylor) polynomial Q(x, y, z) of g(x, y, z) to arbitrary order. 27 June 2014, Zielona Góra (Poland) Introduction to DA 20/56

24 Implementations Arithmetic can be implemented on computer. Critical points: operations must be done efficiently (for large scale computations) fixed order n and variables v are easy, arbitrary numbers of orders and variables more difficult convenient coding for user, requires overloading of operators 27 June 2014, Zielona Góra (Poland) Introduction to DA 21/56

25 Implementations Selected computer implementations of Differential Algebra: COSY INFINITY 9.0 (Berz, Makino 1998) rigorous (TM) and non-rigorous (DA) datatypes computing environment using COSY Script language large library of tools and utilities for beam physics and verified computation long history of active development (20+ years) DACE (Dinamica SRL, 2014) non-rigorous DA datatype comfortable native C++ and experimental Matlab interface large library of celestial mechanics routines currently developed under ESA contract (ITT 7570: Nonlinear Propagation of Uncertainties in Space Dynamics based on Taylor Differential Algebra) JACK (Thales), Jet Transport (Barcelona),... (?) 27 June 2014, Zielona Góra (Poland) Introduction to DA 22/56

26 Mathematical expressions DACE C++ Interface Key Concepts! All operators are overloaded for DA and double operations Independent variables (generators of the algebra) created by simple DA constructor DA(1), DA(2), Overloaded intrinsic routines available for functional programming style sin(x) instead of x.sin() Very clear and easy to understand code DA x = -1 + DA(1) + DA(2); DA y = sin(x) + 1.9;! DA z = x.sin() + 1.9;!// Creation of DA variables!!// Functional notation!!// Object oriented notation! 3!

27 Mathematical expressions DACE C++ Interface Key Concepts! Notation is virtually identical to built in numerical C++ types (e.g. double, int) and C/C++ math library New code can be written easily Existing code can be adapted to DA with minimal changes Does not mean old code will just run! Non-trivial code always requires some changes due to conceptual differences, not the interface! double f(double x)! {!!double res = (sin(x)+2*x)/(1+cos(x));!!for(int i = 0; i<3; i++) res = sqrt(res);!!return res;! }! Existing double code 4!

28 Mathematical expressions DACE C++ Interface Key Concepts! Notation is virtually identical to built in numerical C++ types (e.g. double, int) and C/C++ math library New code can be written easily Existing code can be adapted to DA with minimal changes Does not mean old code will just run! Non-trivial code always requires some changes due to conceptual differences, not the interface! DA f(da x)! {!!DA res = (sin(x)+2*x)/(1+cos(x));!!for(int i = 0; i<3; i++) res = sqrt(res);!!return res;! }! New DA code 5!

29 Mathematical expressions DACE C++ Interface Key Concepts! Using C++ templates allows maximum code flexibility DA class is template safe C++ automatically writes code for any data type used in function call Most versatile, and recommended, way to write functions template<class T> T f(t x)! {!!T res = (sin(x)+2*x)/(1+cos(x));!!for(int i = 0; i<3; i++) res = sqrt(res);!!return res;! }! cout << f(5.0);!// call f with double! cout << f(da(1));!// call f with DA! Hybrid template code 6!

30 as Automatic Differentiation Multivariate Polynomials Automatic Differentiation Functional Analysis Non-Archimedean Analysis Differential Algebra Set Theory Symbolic Computation 27 June 2014, Zielona Góra (Poland) Introduction to DA 27/56

31 as Automatic Differentiation Accurate computation of arbitrary derivatives of a function f at given point x 0 Much faster and more accurate than e.g. divided differences Forward differentiation method 27 June 2014, Zielona Góra (Poland) Introduction to DA 28/56

32 as Automatic Differentiation 27 June 2014, Zielona Góra (Poland) Introduction to DA 28/56 Accurate computation of arbitrary derivatives of a function f at given point x 0 Much faster and more accurate than e.g. divided differences Forward differentiation method Let x 0 R m, f : R m R and compute P( x) = f ( x 0 + x) to some order in DA arithmetic. Then P( x) is the Taylor Expansion of f around x 0, hence contains exact derivatives dk f x0 in coefficients (up to floating point error). d x k

33 as Automatic Differentiation Works because binary DA operations commute with Taylor expansion T a, b F P f, g T F, G T a b f g T F G i.e. T f (x) T g (x) = T f g (x) where T f (x) is Taylor expansion of f up to DA computation order n. 27 June 2014, Zielona Góra (Poland) Introduction to DA 29/56

34 as Automatic Differentiation Same duality between DA and mathematical operation holds for: Each intrinsic DA function G(x) (e.g. sin, cos) G(T f (x)) = T G(f (x)). Evaluation of polynomials in DA arithmetic (function concatenation): T f g (x) = f (T g (x)) = T f (T g (x)) 27 June 2014, Zielona Góra (Poland) Introduction to DA 30/56

35 as an Implementation of Functional Analysis Important consequence of function concatenation: Sensitivity Let f (x), g(x), h(x) be (sufficiently smooth) functions. If the Taylor expansions T g and T h agree up to order k then the Taylor expansions T f (g) and T f (h) agree up to order k a well. Proof: Insert into Taylor expansion or by repeated application of chain rule. 27 June 2014, Zielona Góra (Poland) Introduction to DA 31/56

36 as an Implementation of Functional Analysis Multivariate Polynomials Automatic Differentiation Functional Analysis Non-Archimedean Analysis Differential Algebra Set Theory Symbolic Computation 27 June 2014, Zielona Góra (Poland) Introduction to DA 32/56

37 as an Implementation of Functional Analysis Building on the commutativity of DA operations, use Taylor Polynomials as computer representations of elements of C r function space. Equivalence relation on C r : f n g f k x k = f k 0 x k f and g have same Taylor expansion to order n Factorize C r into equivalence classes by n 0 k = 0,..., n Pick Taylor Polynomial of order n as representative of each class Example: n = x + x2 2 + x3 6 3 exp(x) 3 exp(x) + x 3 sin(x) Use 1 + x + x2 2 + x3 6 as representative of all 3 functions 27 June 2014, Zielona Góra (Poland) Introduction to DA 33/56

38 as an Implementation of Functional Analysis Now use DA representation of Taylor Polynomial as computer representation of C r functions Like floating point numbers are computer representations of R. T a, b R a, b F P f, g T F, G a b T a b f g T F G Field of Math: Objects: Representation: Analysis R Floating Point Numbers Functional Analysis f C r : R n R n Differential Algebra 27 June 2014, Zielona Góra (Poland) Introduction to DA 34/56

39 as an Implementation of Functional Analysis Intuitive manipulation of functions in computer environment Direct computer implementation of e.g. Functional Analysis operators Example: Picard Operator for Flow Expansion Fixed point operator to solve ODE x = f (x), x(0) = x 0. P : C r C r ˆ t P [x(τ)] = x 0 + f (x(τ)) dτ 0 Can be implemented straight forward using DA Integration operator is just algebraic operation Operator P converges to fixed point in n D v in at most n steps (!) 27 June 2014, Zielona Góra (Poland) Introduction to DA 35/56

40 as an Implementation of Functional Analysis DA order function The DA order function O : n D v N { } is the minimum order of all non-zero terms in a monomial, or if the polynomial is zero. Examples: O(2 x 3 y + 4x 2 3) = 0 O(2 x 3 y + 4x 2 ) = 2 O(2 x 3 y) = 4 O(0) = 27 June 2014, Zielona Góra (Poland) Introduction to DA 36/56

41 as an Implementation of Functional Analysis DA fixed point theorem Let A : n D v n D v be an operator on n D v such that x, y n D v Then O(Ax Ay) > O(x y). 1 A has a unique fixed point x 0 n D v, i.e. Ax 0 = x 0 2 For any x n D v the sequence x, Ax, A 2 x, A 3 x,... converges to x 0 order by order, i.e. O(A n x x 0 ) n 27 June 2014, Zielona Góra (Poland) Introduction to DA 37/56

42 as Non-Archimedean Analysis Multivariate Polynomials Automatic Differentiation Functional Analysis Non-Archimedean Analysis Differential Algebra Set Theory Symbolic Computation 27 June 2014, Zielona Góra (Poland) Introduction to DA 38/56

43 as Non-Archimedean Analysis To understand convergence properties on n D v, a view from Non-Archimedean Analysis is useful. Order on n D v can be introduced by comparing coefficients one after another. E.g x 3x 2 < 1 + 2x + 2x 2 Thus n D v has infinitesimal elements: 1 + x > K (0 + x) = Kx K R i.e. any multiple of x is still smaller than 1 + x. 27 June 2014, Zielona Góra (Poland) Introduction to DA 39/56

44 as Non-Archimedean Analysis Axiom of Archimedes ε > 0 n N s.t. 1/n < ε every positive ε can be multiplied by some n such that ε n is larger than 1 Non-Archimedean Analysis: Drop axiom to allow infinitesimals The Levi-Civita Field Rigorous mathematical treatment of algebra with infinitesimals Provides rigorous theoretical underpinning for DA Useful to develop fast implementations of the computation of basic DA algorithms contracting operators: number of correct orders increases by 1 super-convergent operators: number of correct orders doubles 27 June 2014, Zielona Góra (Poland) Introduction to DA 40/56

45 as a Representation of Sets and Manifolds Multivariate Polynomials Automatic Differentiation Functional Analysis Non-Archimedean Analysis Differential Algebra Set Theory Symbolic Computation 27 June 2014, Zielona Góra (Poland) Introduction to DA 41/56

46 as a Representation of Sets and Manifolds DA objects can be considered as representation of very general sets: Consider DA as a (structured) set by looking at image of domain [ 1, 1] n under a polynomial map Can approximate very complicated sets very well Much better approximation of set valued functions than Interval Arithmetic Domain Initial Set Final Set 1,1 δ x,δ y S f -1,-1 -δ x,-δ y P=f(S) 27 June 2014, Zielona Góra (Poland) Introduction to DA 42/56

47 as a Representation of Sets and Manifolds DA objects can be considered as representation of very general sets: Consider DA as a (structured) set by looking at image of domain [ 1, 1] n under a polynomial map Can approximate very complicated sets very well Much better approximation of set valued functions than Interval Arithmetic Domain Initial Set Final Set 1,1 δ x,δ y S f -1,-1 -δ x,-δ y P=f(S) 27 June 2014, Zielona Góra (Poland) Introduction to DA 42/56

48 as a Representation of Sets and Manifolds Set theoretical view of DA allows computation only on selected (sub)sets fast propagation of sets of initial conditions bounding of resulting sets DA representation of sets has a structure Manifolds Instead of one single map, consider many maps each covering part of the initial set Natural representation of the mathematical concept of a manifold by representing the charts of the atlas as DA objects Calculations on manifold very easy 27 June 2014, Zielona Góra (Poland) Introduction to DA 43/56

49 Taylor Models Extension of DA techniques to automatically compute rigorous bounds of truncation errors DA: f ( x 0 + δx) f ( x 0 ) + f ( x 0 ) δx n! f (n) ( x 0 ) δx n TM: f ( x 0 + δx) f ( x 0 ) + f ( x 0 ) δx n! f (n) ( x 0 ) δx n +[ ε, ε] Combined with polynomial bounders provides highly accurate, rigorous bounds for range of f over given domains. Applications in verified numerics: Global Optimization Global Fixed Point Finder Verified Integration Manifold Enclosures = Computer Assisted Proofs 27 June 2014, Zielona Góra (Poland) Introduction to DA 44/56

50 ODE flow expansion Several methods to compute flow expansion ϕ( x 0, t): Picard Operator Iteration (as shown before) DA evaluation of classical numerical schemes Runge Kutta (e.g. RK45, DP78) Adams-Bashforth Never: variational equations! Result of each method: P(δ x, δt) = ϕ( x 0 + δ x, t + δt) First order of P corresponds to state transition matrix Extremely useful to propagate entire sets of initial conditions 27 June 2014, Zielona Góra (Poland) Introduction to DA 45/56

51 ODE flow expansion Uncertainty propagation of reference value r = (r 1, r 2,... ) and uncertainty vector σ = (σ 1, σ 2,... ): 1 Set up the initial condition as the set P initial (δ x) = r + 3 σ T δ x r 1 σ 1 δx 1 = r σ 2 δx 2.. such that on [ 1, 1] n it covers the entire 3 σ set. 2 Propagate polynomial P initial (δ x) using an integration scheme implemented in DA. 3 Result: P final (δ x) describing the 3 σ set after propagation. 27 June 2014, Zielona Góra (Poland) Introduction to DA 46/56

52 ODE flow expansion Example: simple Euler scheme with fixed step size h x i+1 = x i + f (x i ) h 1 Perform steps in DA arithmetic starting with x 0 = P initial (δ x) x 1 = x 0 + f (x 0 ) h 2 Now x 1 = x 1 (δ x) is the polynomial expansion of propagated set at time h. 3 Repeat until final time In reality, use higher order scheme (e.g. DP78). 27 June 2014, Zielona Góra (Poland) Introduction to DA 47/56

53 DA-based ODE flow expansion order: 6 ODE flow expansion Uncertainty box on initial position: 0.00 Propagation of set of initial conditions in Kepler dynamics (set view): y [AU] (a) t i = day t 0 = 0 Com Intel Any s can b order x [AU] 27 June 2014, Zielona Góra (Poland) Introduction to DA 48/56 Fa

54 ODE flow expansion Advanced uncertainty propagation techniques: Domain Splitting: nonlinear dynamics cause sets to grow. Automatically decompose polynomial into smaller polynomials covering subsets to ensure convergence. Taylor integrator: arbitrary order integrator using the Taylor flow expansion. Instead of numerical scheme, use Taylor flow expansion and compute and evaluate at each time step. Verified integration: Taylor integrator extended with verified Taylor Models. Compute verified enclosure of flow including truncation and round-off errors in each step. Yields verified enclosure of set (computer assisted proof). 27 June 2014, Zielona Góra (Poland) Introduction to DA 49/56

55 as Symbolic Computation Multivariate Polynomials Automatic Differentiation Functional Analysis Non-Archimedean Analysis Differential Algebra Set Theory Symbolic Computation 27 June 2014, Zielona Góra (Poland) Introduction to DA 50/56

56 as Symbolic Computation DA can be viewed as a hybrid of symbolic and numeric computation: Polynomials are treated symbolically up to order n Results are again polynomials, not a more complicated symbolic expression Combines speed of numerical with many advantages of symbolic computation 27 June 2014, Zielona Góra (Poland) Introduction to DA 51/56

57 Algorithms Some basic DA algorithms: Function inversion to arbitrary order Constraint satisfaction Taylor expansion of ODE flow in time in initial conditions (no need for variational equations) Poincare map computation (combining ODE flow & constraint satisfaction) Two Point Boundary Value Problem (TPBVP) Normal Form transformation Manifold expansion 27 June 2014, Zielona Góra (Poland) Introduction to DA 52/56

58 Aerospace Applications Over past 8 years, DA techniques have been applied to many problems: Uncertainty propagation Fast Monte Carlo methods Propagation of statistics MOID & Collision probability Robustness analysis and optimization Orbit determination Dynamics structure determination (LCS) Map propagation method Manifold representation local manifold generation manifold globalization Lambert problem (extension methods) Robust optimal control Global optimization of interplanetary transfers 27 June 2014, Zielona Góra (Poland) Introduction to DA 53/56

59 References (Aerospace) Uncertainty propagation in astrodynamics: Pierluigi Di Lizia and Roberto Armellin s PhD theses ( ) Armellin R., Di Lizia P., Bernelli Zazzera F., Berz M. Asteroid Close Encounters Characterization Using Differential Algebra: the Case of Apophis, Celestial Mechanics and Dynamical Astronomy, 2010 Valli M., Armellin R., Di Lizia P., Lavagna M., Nonlinear Mapping of Uncertainties in Celestial Mechanics, Journal of Guidance Control and Dynamics, 2013 TPBVP in astrodynamics: Pierluigi Di Lizia and Roberto Armellin s PhD theses ( ) Di Lizia P., Armellin R., Lavagna M., Application of High Order Expansions of Two-Point Boundary Value Problems to Astrodynamics, Celestial Mechanics and Dynamical Astronomy, 2008 Orbit Determination: Armellin R., Di Lizia P., Lavagna M., High-Order Expansion of the Solution of Preliminary Orbit Determination Problem, Celestial Mechanics and Dynamical Astronomy, 2012 MOID and collision probability computation: Armellin R., Di Lizia P., Berz M., Makino K., Computing the Critical Points of the Distance Function Between Two Keplerian Orbits via Rigorous Global Optimization, Celestial Mechanics and Dynamical Astronomy, 2010 Armellin R., Morselli A., Di Lizia P., Lavagna M., Rigorous Computation of Orbital Conjunctions, Advances in Space Research, 2012 Morselli A., Armellin R., Di Lizia P., Bernelli Zazzera F., A High Order Method for Orbital Conjunctions Analysis: Sensitivity to Initial Uncertainties, Advances in Space Research, June 2014, Zielona Góra (Poland) Introduction to DA 54/56

60 References (Aerospace) Robust optimal control of space trajectories: Pierluigi Di Lizia and Roberto Armellin s PhD theses ( ) Di Lizia P., Armellin R., Ercoli Finzi A., Berz M., High-Order Robust Guidance of Interplanetary Trajectories Based on Differential Algebra, Journal of Aerospace Engineering, Sciences and Applications, 2008 Di Lizia P., Armellin R., Bernelli Zazzera F., Berz M., High Order Optimal Control of Space Trajectories with Uncertain Boundary Conditions, Acta Astronautica, 2014 Di Lizia P., Armellin R., Morselli A., Bernelli Zazzera F., High Order Optimal Feedback Control of Space Trajectories with Bounded Control, Acta Astronautica, 2014 Global optimization of interplanetary transfers: Armellin R., Di Lizia P., Topputo F., Lavagna M., Bernelli Zazzera F., Berz M., Gravity Assist Space Pruning Based on Differential Algebra, Celestial Mechanics and Dynamical Astronomy, 2010 Armellin R., Di Lizia P., Makino K., Berz M., Rigorous Global Optimization of Impulsive Planet-to-Planet Transfers in the Patched-Conics Approximation, Engineering Optimization, 2012 Awarded grants on DA application to space-related problems: Global Trajectory Optimization: Can We Prune the Solution Space when considering Deep Space Manouvres? ESA Contract, 2007 Predicting Asteroid Trajectories using Validated Integrators and Determining Impact Leading Conditions. ESA Contract, 2008 Trajectory optimisation under uncertainties: a differential algebra approach. ESA Contract, 2011 Nonlinear Propagation of Uncertainties in Space Dynamics based on Taylor Differential Algebra, ESA contract June 2014, Zielona Góra (Poland) Introduction to DA 55/56

61 References (Differential Algebra) Berz, M The method of power series tracking for the mathematical description of beam dynamics. Nuclear Instruments and Methods, A258, Berz, M Modern Map Methods in Particle Beam Physics. San Diego: Academic Press. Also available at Lizia, P. Di, Zazzera, F. Bernelli, & Berz, M High Order Integration and Sensitivity Analysis of Multibody Systems using Differential Algebra. AIDAA, 19. Makino, K., & Berz, M Remainder Differential Algebras and their Applications. Pages of: Berz, M., Bischof, C., Corliss, G., & Griewank, A. (eds), Computational Differentiation: Techniques, Applications, and Tools. Philadelphia: SIAM. 27 June 2014, Zielona Góra (Poland) Introduction to DA 56/56

An Introduction to Differential Algebra

An Introduction to Differential Algebra An Introduction to Differential Algebra Alexander Wittig1, P. Di Lizia, R. Armellin, et al. 1 ESA Advanced Concepts Team (TEC-SF) SRL, Milan Dinamica Outline 1 Overview Five Views of Differential Algebra

More information

Relevant Applications of Differential Algebra in Astrodynamics

Relevant Applications of Differential Algebra in Astrodynamics AstroNet-II International Final Conference Tossa de Mar 15-19 June 2015 Relevant Applications of Differential Algebra in Astrodynamics Pierluigi Di Lizia in collaboration with: Roberto Armellin, Alessandro

More information

Two-Point Boundary Value Problem and Optimal Feedback Control based on Differential Algebra

Two-Point Boundary Value Problem and Optimal Feedback Control based on Differential Algebra Two-Point Boundary Value Problem and Optimal Feedback Control based on Differential Algebra Politecnico di Milano Department of Aerospace Engineering Milan, Italy Taylor Methods and Computer Assisted Proofs

More information

Accurate numerical orbit propagation using Polynomial Algebra Computational Engine PACE. ISSFD 2015 congress, Germany. Dated: September 14, 2015

Accurate numerical orbit propagation using Polynomial Algebra Computational Engine PACE. ISSFD 2015 congress, Germany. Dated: September 14, 2015 Accurate numerical orbit propagation using Polynomial Algebra Computational Engine PACE Emmanuel Bignon (), Pierre mercier (), Vincent Azzopardi (), Romain Pinède () ISSFD 205 congress, Germany Dated:

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

Rigorous Global Optimization of Impulsive Space Trajectories

Rigorous Global Optimization of Impulsive Space Trajectories Rigorous Global Optimization of Impulsive Space Trajectories P. Di Lizia, R. Armellin, M. Lavagna K. Makino, M. Berz Fourth International Workshop on Taylor Methods Boca Raton, December 16 19, 2006 Motivation

More information

Verified High-Order Optimal Control in Space Flight Dynamics

Verified High-Order Optimal Control in Space Flight Dynamics Verified High-Order Optimal Control in Space Flight Dynamics R. Armellin, P. Di Lizia, F. Bernelli-Zazzera K. Makino and M. Berz Fourth International Workshop on Taylor Methods Boca Raton, December 16

More information

Trajectory Optimisation under Uncertainties

Trajectory Optimisation under Uncertainties Trajectory Optimisation under Uncertainties Final Report Authors: F. Bernelli-Zazzera, M. Lavagna, R. Armellin, P. Di Lizia, A. Morselli Affiliation: Department of Aerospace Engineering, Politecnico di

More information

Global Optimization of Impulsive Interplanetary Transfers

Global Optimization of Impulsive Interplanetary Transfers Global Optimization of Impulsive Interplanetary Transfers R. Armellin, Dipartimento di Ingegneria Aerospaziale, Politecnico di Milano Taylor Methods and Computer Assisted Proofs Barcelona, June, 3 7, 2008

More information

COSY INFINITY Version 7

COSY INFINITY Version 7 COSY INFINITY Version 7 Kyoko Makino and Martin Berz Department of Physics and Astronomy and National Superconducting Cyclotron Laboratory Michigan State University, East Lansing, MI 48824 Abstract An

More information

Validated integration of Solar System Dynamics. 1 st IAA Planetary Defense Conference: Protecting Earth from Asteroids

Validated integration of Solar System Dynamics. 1 st IAA Planetary Defense Conference: Protecting Earth from Asteroids Validated integration of Solar System Dynamics 1 st IAA Planetary Defense Conference: Protecting Earth from Asteroids 27-3 April 29 Granada, Spain P. Di Lizia (1), R. Armellin (1), F. Bernelli Zazzera

More information

Global Trajectory Optimisation: Can We Prune the Solution Space when Considering Deep Space Maneuvers?

Global Trajectory Optimisation: Can We Prune the Solution Space when Considering Deep Space Maneuvers? Global Trajectory Optimisation: Can We Prune the Solution Space when Considering Deep Space Maneuvers? Final Report Authors: F. Bernelli-Zazzera, M. Lavagna, R. Armellin, P. Di Lizia, F. Topputo Affiliation:

More information

Apophis Encounter 2029: Differential Algebra and Taylor Model Approaches. 1 st IAA Planetary Defense Conference: Protecting Earth from Asteroids

Apophis Encounter 2029: Differential Algebra and Taylor Model Approaches. 1 st IAA Planetary Defense Conference: Protecting Earth from Asteroids Apophis Encounter 9: Differential Algebra and Taylor Model Approaches 1 st IAA Planetary Defense Conference: Protecting Earth from Asteroids 7- April 9 Granada, Spain R. Armellin (1), P. Di Lizia (1),

More information

Uncertainties Management for Orbit Propagation using Taylor Differential Algebra

Uncertainties Management for Orbit Propagation using Taylor Differential Algebra Uncertainties Management for Orbit Propagation using aylor Differential Algebra Vincent Azzopardi hales ervices, pace Flight Dynamics department, oulouse, France Institut upérieur de l Aéronautique et

More information

DIFFERENTIAL ALGEBRA SPACE TOOLBOX FOR NONLINEAR UNCERTAINTY PROPAGATION IN SPACE DYNAMICS

DIFFERENTIAL ALGEBRA SPACE TOOLBOX FOR NONLINEAR UNCERTAINTY PROPAGATION IN SPACE DYNAMICS DIFFERENTIAL ALGEBRA SPACE TOOLBOX FOR NONLINEAR UNCERTAINTY PROPAGATION IN SPACE DYNAMICS M. Rasotto, A. Morselli, A. Wittig, M. Massari, P. Di Lizia, R. Armellin, C. Y. Valles and G. Ortega Dinamica

More information

EFFECTS OF THE WIGGLER ON THE HEFEI LIGHT SOURCE STORAGE RING

EFFECTS OF THE WIGGLER ON THE HEFEI LIGHT SOURCE STORAGE RING International Journal of Modern Physics A Vol. 24, No. 5 (2009) 1057 1067 c World Scientific Publishing Company EFFECTS OF THE WIGGLER ON THE HEFEI LIGHT SOURCE STORAGE RING HE ZHANG and MARTIN BERZ Department

More information

Verified Global Optimization with Taylor Model based Range Bounders

Verified Global Optimization with Taylor Model based Range Bounders Verified Global Optimization with Taylor Model based Range Bounders KYOKO MAKINO and MARTIN BERZ Department of Physics and Astronomy Michigan State University East Lansing, MI 88 USA makino@msu.edu, berz@msu.edu

More information

Interval Methods and Taylor Model Methods for ODEs

Interval Methods and Taylor Model Methods for ODEs Interval Methods and Taylor Model Methods for ODEs Markus Neher, Dept. of Mathematics KARLSRUHE INSTITUTE OF TECHNOLOGY (KIT) 0 TM VII, Key West KIT University of the State of Baden-Wuerttemberg and Interval

More information

NONLINEAR MAPPING OF UNCERTAINTIES: A DIFFERENTIAL ALGEBRAIC APPROACH

NONLINEAR MAPPING OF UNCERTAINTIES: A DIFFERENTIAL ALGEBRAIC APPROACH NONLINEAR MAPPING OF UNCERTAINTIES: A DIFFERENTIAL ALGEBRAIC APPROACH R. Armellin 1, P. DiLizia 1, F. Bernelli-Zazzera 1, and M. Berz 2 1 Dipartimento di Ingegneria Aerospaziale, Politecnico di Milano,

More information

Nonlinear Dynamics - Methods and Tools. and a Contemporary ( ) framework. to treat Linear and Nonlinear Beam Dynamics PART 3

Nonlinear Dynamics - Methods and Tools. and a Contemporary ( ) framework. to treat Linear and Nonlinear Beam Dynamics PART 3 Nonlinear Dynamics - Methods and Tools and a Contemporary (1985 + ) framework to treat Linear and Nonlinear Beam Dynamics PART 3 What about a complicated arrangement, e.g. one that can only be simulated

More information

A high order method for orbital conjunctions analysis: Monte Carlo collision probability computation

A high order method for orbital conjunctions analysis: Monte Carlo collision probability computation A high order method for orbital conjunctions analysis: Monte Carlo collision probability computation Alessandro Morselli 1, Dipartimento di Scienze e Tecnologie Aerospaziali, Politecnico di Milano, Via

More information

COSY INFINITY version 8

COSY INFINITY version 8 Nuclear Instruments and Methods in Physics Research A 427 (1999) 338}343 COSY INFINITY version 8 Kyoko Makino*, Martin Berz Department of Physics and National Superconducting Cyclotron Laboratory, Michigan

More information

Feedback Optimal Control of Low-thrust Orbit Transfer in Central Gravity Field

Feedback Optimal Control of Low-thrust Orbit Transfer in Central Gravity Field Vol. 4, No. 4, 23 Feedback Optimal Control of Low-thrust Orbit Transfer in Central Gravity Field Ashraf H. Owis Department of Astronomy, Space and Meteorology, Faculty of Science, Cairo University Department

More information

Application of Taylor Models to the Worst-Case Analysis of Stripline Interconnects

Application of Taylor Models to the Worst-Case Analysis of Stripline Interconnects Application of Taylor Models to the Worst-Case Analysis of Stripline Interconnects Paolo Manfredi, Riccardo Trinchero, Igor Stievano, Flavio Canavero Email: paolo.manfredi@ugent.be riccardo.trinchero@to.infn.it,

More information

COMPUTER ARITHMETIC. 13/05/2010 cryptography - math background pp. 1 / 162

COMPUTER ARITHMETIC. 13/05/2010 cryptography - math background pp. 1 / 162 COMPUTER ARITHMETIC 13/05/2010 cryptography - math background pp. 1 / 162 RECALL OF COMPUTER ARITHMETIC computers implement some types of arithmetic for instance, addition, subtratction, multiplication

More information

Chapter 11. Taylor Series. Josef Leydold Mathematical Methods WS 2018/19 11 Taylor Series 1 / 27

Chapter 11. Taylor Series. Josef Leydold Mathematical Methods WS 2018/19 11 Taylor Series 1 / 27 Chapter 11 Taylor Series Josef Leydold Mathematical Methods WS 2018/19 11 Taylor Series 1 / 27 First-Order Approximation We want to approximate function f by some simple function. Best possible approximation

More information

Taylor Model Range Bounding Schemes

Taylor Model Range Bounding Schemes Taylor Model Range Bounding Schemes I Kyoko Makino II Martin Berz Department of Physics and Astronomy Michigan State University Introduction LDB (Linear Dominated Bounder) QDB (Quadratic Dominated Bounder)

More information

SMART-UQ: UNCERTAINTY QUANTIFICATION TOOLBOX FOR GENERALISED INTRUSIVE AND NON INTRUSIVE POLYNOMIAL ALGEBRA

SMART-UQ: UNCERTAINTY QUANTIFICATION TOOLBOX FOR GENERALISED INTRUSIVE AND NON INTRUSIVE POLYNOMIAL ALGEBRA SMART-UQ: UNCERTAINTY QUANTIFICATION TOOLBOX FOR GENERALISED INTRUSIVE AND NON INTRUSIVE POLYNOMIAL ALGEBRA Ortega C., Riccardi A., Vasile M., Tardioli C. University of Strathclyde Department of Mechanical

More information

Chapter 1 Mathematical Preliminaries and Error Analysis

Chapter 1 Mathematical Preliminaries and Error Analysis Numerical Analysis (Math 3313) 2019-2018 Chapter 1 Mathematical Preliminaries and Error Analysis Intended learning outcomes: Upon successful completion of this chapter, a student will be able to (1) list

More information

Validated Explicit and Implicit Runge-Kutta Methods

Validated Explicit and Implicit Runge-Kutta Methods Validated Explicit and Implicit Runge-Kutta Methods Alexandre Chapoutot joint work with Julien Alexandre dit Sandretto and Olivier Mullier U2IS, ENSTA ParisTech 8th Small Workshop on Interval Methods,

More information

MATH 1902: Mathematics for the Physical Sciences I

MATH 1902: Mathematics for the Physical Sciences I MATH 1902: Mathematics for the Physical Sciences I Dr Dana Mackey School of Mathematical Sciences Room A305 A Email: Dana.Mackey@dit.ie Dana Mackey (DIT) MATH 1902 1 / 46 Module content/assessment Functions

More information

Verification of Invertibility of Complicated Functions over Large Domains

Verification of Invertibility of Complicated Functions over Large Domains Reliable Computing 8: 67 82, 2002. 67 c 2002 Kluwer Academic Publishers. Printed in the Netherlands. Verification of Invertibility of Complicated Functions over Large Domains JENS HOEFKENS and MARTIN BERZ

More information

Introduction to Numerical Analysis

Introduction to Numerical Analysis Introduction to Numerical Analysis S. Baskar and S. Sivaji Ganesh Department of Mathematics Indian Institute of Technology Bombay Powai, Mumbai 400 076. Introduction to Numerical Analysis Lecture Notes

More information

Simulation and Optimization of the Tevatron Accelerator

Simulation and Optimization of the Tevatron Accelerator Simulation and Optimization of the Tevatron Accelerator Pavel Snopok, Carol Johnstone, and Martin Berz 3 Fermi National Accelerator Laboratory, Michigan State University, snopok@pa.msu.edu Fermi National

More information

Work in Progress: Reachability Analysis for Time-triggered Hybrid Systems, The Platoon Benchmark

Work in Progress: Reachability Analysis for Time-triggered Hybrid Systems, The Platoon Benchmark Work in Progress: Reachability Analysis for Time-triggered Hybrid Systems, The Platoon Benchmark François Bidet LIX, École polytechnique, CNRS Université Paris-Saclay 91128 Palaiseau, France francois.bidet@polytechnique.edu

More information

Math 155 Prerequisite Review Handout

Math 155 Prerequisite Review Handout Math 155 Prerequisite Review Handout August 23, 2010 Contents 1 Basic Mathematical Operations 2 1.1 Examples...................................... 2 1.2 Exercises.......................................

More information

ECEN 5682 Theory and Practice of Error Control Codes

ECEN 5682 Theory and Practice of Error Control Codes ECEN 5682 Theory and Practice of Error Control Codes Introduction to Algebra University of Colorado Spring 2007 Motivation and For convolutional codes it was convenient to express the datawords and the

More information

Homework and Computer Problems for Math*2130 (W17).

Homework and Computer Problems for Math*2130 (W17). Homework and Computer Problems for Math*2130 (W17). MARCUS R. GARVIE 1 December 21, 2016 1 Department of Mathematics & Statistics, University of Guelph NOTES: These questions are a bare minimum. You should

More information

EXAMPLES OF PROOFS BY INDUCTION

EXAMPLES OF PROOFS BY INDUCTION EXAMPLES OF PROOFS BY INDUCTION KEITH CONRAD 1. Introduction In this handout we illustrate proofs by induction from several areas of mathematics: linear algebra, polynomial algebra, and calculus. Becoming

More information

Ch 7 Summary - POLYNOMIAL FUNCTIONS

Ch 7 Summary - POLYNOMIAL FUNCTIONS Ch 7 Summary - POLYNOMIAL FUNCTIONS 1. An open-top box is to be made by cutting congruent squares of side length x from the corners of a 8.5- by 11-inch sheet of cardboard and bending up the sides. a)

More information

REVIEW OF DIFFERENTIAL CALCULUS

REVIEW OF DIFFERENTIAL CALCULUS REVIEW OF DIFFERENTIAL CALCULUS DONU ARAPURA 1. Limits and continuity To simplify the statements, we will often stick to two variables, but everything holds with any number of variables. Let f(x, y) be

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

Propagation of Uncertainties in Nonlinear Dynamic Models

Propagation of Uncertainties in Nonlinear Dynamic Models Propagation of Uncertainties in Nonlinear Dynamic Models Youdong Lin 1, Scott Ferson 2, George F. Corliss 3 and Mark A. Stadtherr 1 1 Department of Chemical and Biomolecular Engineering, University of

More information

B553 Lecture 1: Calculus Review

B553 Lecture 1: Calculus Review B553 Lecture 1: Calculus Review Kris Hauser January 10, 2012 This course requires a familiarity with basic calculus, some multivariate calculus, linear algebra, and some basic notions of metric topology.

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

Physics 584 Computational Methods

Physics 584 Computational Methods Physics 584 Computational Methods Introduction to Matlab and Numerical Solutions to Ordinary Differential Equations Ryan Ogliore April 18 th, 2016 Lecture Outline Introduction to Matlab Numerical Solutions

More information

An Overly Simplified and Brief Review of Differential Equation Solution Methods. 1. Some Common Exact Solution Methods for Differential Equations

An Overly Simplified and Brief Review of Differential Equation Solution Methods. 1. Some Common Exact Solution Methods for Differential Equations An Overly Simplified and Brief Review of Differential Equation Solution Methods We will be dealing with initial or boundary value problems. A typical initial value problem has the form y y 0 y(0) 1 A typical

More information

Chapter 1: Introduction and mathematical preliminaries

Chapter 1: Introduction and mathematical preliminaries Chapter 1: Introduction and mathematical preliminaries Evy Kersalé September 26, 2011 Motivation Most of the mathematical problems you have encountered so far can be solved analytically. However, in real-life,

More information

Computing validated solutions of implicit differential equations

Computing validated solutions of implicit differential equations Advances in Computational Mathematics 19: 231 253, 2003. 2003 Kluwer Academic Publishers. Printed in the Netherlands. Computing validated solutions of implicit differential equations Jens Hoefkens a, Martin

More information

Finite difference models: one dimension

Finite difference models: one dimension Chapter 6 Finite difference models: one dimension 6.1 overview Our goal in building numerical models is to represent differential equations in a computationally manageable way. A large class of numerical

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

15 Nonlinear Equations and Zero-Finders

15 Nonlinear Equations and Zero-Finders 15 Nonlinear Equations and Zero-Finders This lecture describes several methods for the solution of nonlinear equations. In particular, we will discuss the computation of zeros of nonlinear functions f(x).

More information

The Existence of Chaos in the Lorenz System

The Existence of Chaos in the Lorenz System The Existence of Chaos in the Lorenz System Sheldon E. Newhouse Mathematics Department Michigan State University E. Lansing, MI 48864 joint with M. Berz, K. Makino, A. Wittig Physics, MSU Y. Zou, Math,

More information

Linear Algebra. Min Yan

Linear Algebra. Min Yan Linear Algebra Min Yan January 2, 2018 2 Contents 1 Vector Space 7 1.1 Definition................................. 7 1.1.1 Axioms of Vector Space..................... 7 1.1.2 Consequence of Axiom......................

More information

Is the Hénon map chaotic

Is the Hénon map chaotic Is the Hénon map chaotic Zbigniew Galias Department of Electrical Engineering AGH University of Science and Technology, Poland, galias@agh.edu.pl International Workshop on Complex Networks and Applications

More information

High-order representation of Poincare maps

High-order representation of Poincare maps Nuclear Instruments and Methods in Physics Research A 558 (2006) 106 111 wwwelseviercom/locate/nima High-order representation of Poincare maps Johannes Grote, Martin Berz, Kyoko Makino Department of Physics

More information

INTERPLANETARY AND LUNAR TRANSFERS USING LIBRATION POINTS

INTERPLANETARY AND LUNAR TRANSFERS USING LIBRATION POINTS INTERPLANETARY AND LUNAR TRANSFERS USING LIBRATION POINTS Francesco Topputo (), Massimiliano Vasile () and Franco Bernelli-Zazzera () () Dipartimento di Ingegneria Aerospaziale, Politecnico di Milano,

More information

For those of you who are taking Calculus AB concurrently with AP Physics, I have developed a

For those of you who are taking Calculus AB concurrently with AP Physics, I have developed a AP Physics C: Mechanics Greetings, For those of you who are taking Calculus AB concurrently with AP Physics, I have developed a brief introduction to Calculus that gives you an operational knowledge of

More information

Chapter 8: Taylor s theorem and L Hospital s rule

Chapter 8: Taylor s theorem and L Hospital s rule Chapter 8: Taylor s theorem and L Hospital s rule Theorem: [Inverse Mapping Theorem] Suppose that a < b and f : [a, b] R. Given that f (x) > 0 for all x (a, b) then f 1 is differentiable on (f(a), f(b))

More information

Invariant Manifolds and Transport in the Three-Body Problem

Invariant Manifolds and Transport in the Three-Body Problem Dynamical S C C A L T E C H Invariant Manifolds and Transport in the Three-Body Problem Shane D. Ross Control and Dynamical Systems California Institute of Technology Classical N-Body Systems and Applications

More information

Lecture 5: Random numbers and Monte Carlo (Numerical Recipes, Chapter 7) Motivations for generating random numbers

Lecture 5: Random numbers and Monte Carlo (Numerical Recipes, Chapter 7) Motivations for generating random numbers Lecture 5: Random numbers and Monte Carlo (Numerical Recipes, Chapter 7) Motivations for generating random numbers To sample a function in a statistically controlled manner (i.e. for Monte Carlo integration)

More information

Making Models with Polynomials: Taylor Series

Making Models with Polynomials: Taylor Series Making Models with Polynomials: Taylor Series Why polynomials? i a 3 x 3 + a 2 x 2 + a 1 x + a 0 How do we write a general degree n polynomial? n a i x i i=0 Why polynomials and not something else? We

More information

ABSTRACT VECTOR SPACES AND THE CONCEPT OF ISOMORPHISM. Executive summary

ABSTRACT VECTOR SPACES AND THE CONCEPT OF ISOMORPHISM. Executive summary ABSTRACT VECTOR SPACES AND THE CONCEPT OF ISOMORPHISM MATH 196, SECTION 57 (VIPUL NAIK) Corresponding material in the book: Sections 4.1 and 4.2. General stuff... Executive summary (1) There is an abstract

More information

Massimiliano Vasile, Stefano Campagnola, Paolo Depascale, Stefano Pessina, Francesco Topputo

Massimiliano Vasile, Stefano Campagnola, Paolo Depascale, Stefano Pessina, Francesco Topputo A Toolbox for Preliminary Massimiliano Vasile, Stefano Campagnola, Paolo Depascale, Stefano Pessina, Francesco Topputo Mission Analysis and Design PAMSIT IMAGO ATOM-C EPIC Massimiliano Vasile, Stefano

More information

Exam in TMA4215 December 7th 2012

Exam in TMA4215 December 7th 2012 Norwegian University of Science and Technology Department of Mathematical Sciences Page of 9 Contact during the exam: Elena Celledoni, tlf. 7359354, cell phone 48238584 Exam in TMA425 December 7th 22 Allowed

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

A Polynomial Chaos Approach to Robust Multiobjective Optimization

A Polynomial Chaos Approach to Robust Multiobjective Optimization A Polynomial Chaos Approach to Robust Multiobjective Optimization Silvia Poles 1, Alberto Lovison 2 1 EnginSoft S.p.A., Optimization Consulting Via Giambellino, 7 35129 Padova, Italy s.poles@enginsoft.it

More information

Compute the behavior of reality even if it is impossible to observe the processes (for example a black hole in astrophysics).

Compute the behavior of reality even if it is impossible to observe the processes (for example a black hole in astrophysics). 1 Introduction Read sections 1.1, 1.2.1 1.2.4, 1.2.6, 1.3.8, 1.3.9, 1.4. Review questions 1.1 1.6, 1.12 1.21, 1.37. The subject of Scientific Computing is to simulate the reality. Simulation is the representation

More information

Convergence of sequences and series

Convergence of sequences and series Convergence of sequences and series A sequence f is a map from N the positive integers to a set. We often write the map outputs as f n rather than f(n). Often we just list the outputs in order and leave

More information

Chapter 3. Rings. The basic commutative rings in mathematics are the integers Z, the. Examples

Chapter 3. Rings. The basic commutative rings in mathematics are the integers Z, the. Examples Chapter 3 Rings Rings are additive abelian groups with a second operation called multiplication. The connection between the two operations is provided by the distributive law. Assuming the results of Chapter

More information

PowerPoints organized by Dr. Michael R. Gustafson II, Duke University

PowerPoints organized by Dr. Michael R. Gustafson II, Duke University Part 5 Chapter 21 Numerical Differentiation PowerPoints organized by Dr. Michael R. Gustafson II, Duke University 1 All images copyright The McGraw-Hill Companies, Inc. Permission required for reproduction

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

Lecture Notes to Accompany. Scientific Computing An Introductory Survey. by Michael T. Heath. Chapter 9

Lecture Notes to Accompany. Scientific Computing An Introductory Survey. by Michael T. Heath. Chapter 9 Lecture Notes to Accompany Scientific Computing An Introductory Survey Second Edition by Michael T. Heath Chapter 9 Initial Value Problems for Ordinary Differential Equations Copyright c 2001. Reproduction

More information

Uncertainty Propagation and Nonlinear Filtering for Space Navigation using Differential Algebra

Uncertainty Propagation and Nonlinear Filtering for Space Navigation using Differential Algebra Uncertainty Propagation and Nonlinear Filtering for Space Navigation using Differential Algebra M. Valli, R. Arellin, P. Di Lizia and M. R. Lavagna Departent of Aerospace Engineering, Politecnico di Milano

More information

Chapter 9 Uniform Circular Motion

Chapter 9 Uniform Circular Motion 9.1 Introduction Chapter 9 Uniform Circular Motion Special cases often dominate our study of physics, and circular motion is certainly no exception. We see circular motion in many instances in the world;

More information

Example 1 Which of these functions are polynomials in x? In the case(s) where f is a polynomial,

Example 1 Which of these functions are polynomials in x? In the case(s) where f is a polynomial, 1. Polynomials A polynomial in x is a function of the form p(x) = a 0 + a 1 x + a 2 x 2 +... a n x n (a n 0, n a non-negative integer) where a 0, a 1, a 2,..., a n are constants. We say that this polynomial

More information

Section 3.1 Quadratic Functions

Section 3.1 Quadratic Functions Chapter 3 Lecture Notes Page 1 of 72 Section 3.1 Quadratic Functions Objectives: Compare two different forms of writing a quadratic function Find the equation of a quadratic function (given points) Application

More information

Escape Trajectories from Sun Earth Distant Retrograde Orbits

Escape Trajectories from Sun Earth Distant Retrograde Orbits Trans. JSASS Aerospace Tech. Japan Vol. 4, No. ists30, pp. Pd_67-Pd_75, 06 Escape Trajectories from Sun Earth Distant Retrograde Orbits By Yusue OKI ) and Junichiro KAWAGUCHI ) ) Department of Aeronautics

More information

TABLE OF CONTENTS INTRODUCTION, APPROXIMATION & ERRORS 1. Chapter Introduction to numerical methods 1 Multiple-choice test 7 Problem set 9

TABLE OF CONTENTS INTRODUCTION, APPROXIMATION & ERRORS 1. Chapter Introduction to numerical methods 1 Multiple-choice test 7 Problem set 9 TABLE OF CONTENTS INTRODUCTION, APPROXIMATION & ERRORS 1 Chapter 01.01 Introduction to numerical methods 1 Multiple-choice test 7 Problem set 9 Chapter 01.02 Measuring errors 11 True error 11 Relative

More information

NUMERICAL INTEGRATION OF CONSTRAINED MULTI-BODY DYNAMICAL SYSTEMS USING 5 T H ORDER EXACT ANALYTIC CONTINUATION ALGORITHM

NUMERICAL INTEGRATION OF CONSTRAINED MULTI-BODY DYNAMICAL SYSTEMS USING 5 T H ORDER EXACT ANALYTIC CONTINUATION ALGORITHM (Preprint) AAS 12-638 NUMERICAL INTEGRATION OF CONSTRAINED MULTI-BODY DYNAMICAL SYSTEMS USING 5 T H ORDER EXACT ANALYTIC CONTINUATION ALGORITHM Ahmad Bani Younes, and James Turner Many numerical integration

More information

Chapter 6 - Ordinary Differential Equations

Chapter 6 - Ordinary Differential Equations Chapter 6 - Ordinary Differential Equations 7.1 Solving Initial-Value Problems In this chapter, we will be interested in the solution of ordinary differential equations. Ordinary differential equations

More information

AIMS Exercise Set # 1

AIMS Exercise Set # 1 AIMS Exercise Set #. Determine the form of the single precision floating point arithmetic used in the computers at AIMS. What is the largest number that can be accurately represented? What is the smallest

More information

5.5 Special Rights. A Solidify Understanding Task

5.5 Special Rights. A Solidify Understanding Task SECONDARY MATH III // MODULE 5 MODELING WITH GEOMETRY 5.5 In previous courses you have studied the Pythagorean theorem and right triangle trigonometry. Both of these mathematical tools are useful when

More information

International Journal of Pure and Applied Mathematics Volume 6 No , TAYLOR MODELS AND OTHER VALIDATED FUNCTIONAL INCLUSION METHODS

International Journal of Pure and Applied Mathematics Volume 6 No , TAYLOR MODELS AND OTHER VALIDATED FUNCTIONAL INCLUSION METHODS International Journal of Pure and Applied Mathematics Volume 6 No. 3 2003, 239-312 TAYLOR MODELS AND OTHER VALIDATED FUNCTIONAL INCLUSION METHODS Kyoko Makino 1, Martin Berz 2 1 Department of Physics University

More information

Calculus with business applications, Lehigh U, Lecture 01 notes Summer

Calculus with business applications, Lehigh U, Lecture 01 notes Summer Calculus with business applications, Lehigh U, Lecture 01 notes Summer 2012 1 Functions 1. A company sells 100 widgets at a price of $20. Sales increase by 5 widgets for each $1 decrease in price. Write

More information

Lecture 1. MA2730: Analysis I. Lecture slides for MA2730 Analysis I. Functions Level 1 revision. MA2730: topics for Lecture 1

Lecture 1. MA2730: Analysis I. Lecture slides for MA2730 Analysis I. Functions Level 1 revision. MA2730: topics for Lecture 1 Contents of the teaching and assessment blocks MA2730: Analysis I Lecture slides for MA2730 Analysis I Simon people.brunel.ac.uk/~icsrsss simon.shaw@brunel.ac.uk College of Engineering, Design and Physical

More information

Mathematics for Engineers. Numerical mathematics

Mathematics for Engineers. Numerical mathematics Mathematics for Engineers Numerical mathematics Integers Determine the largest representable integer with the intmax command. intmax ans = int32 2147483647 2147483647+1 ans = 2.1475e+09 Remark The set

More information

Introduction to Finite Di erence Methods

Introduction to Finite Di erence Methods Introduction to Finite Di erence Methods ME 448/548 Notes Gerald Recktenwald Portland State University Department of Mechanical Engineering gerry@pdx.edu ME 448/548: Introduction to Finite Di erence Approximation

More information

McGill University Department of Mathematics and Statistics. Ph.D. preliminary examination, PART A. PURE AND APPLIED MATHEMATICS Paper BETA

McGill University Department of Mathematics and Statistics. Ph.D. preliminary examination, PART A. PURE AND APPLIED MATHEMATICS Paper BETA McGill University Department of Mathematics and Statistics Ph.D. preliminary examination, PART A PURE AND APPLIED MATHEMATICS Paper BETA 17 August, 2018 1:00 p.m. - 5:00 p.m. INSTRUCTIONS: (i) This paper

More information

Algorithmic Lie Symmetry Analysis and Group Classication for Ordinary Dierential Equations

Algorithmic Lie Symmetry Analysis and Group Classication for Ordinary Dierential Equations dmitry.lyakhov@kaust.edu.sa Symbolic Computations May 4, 2018 1 / 25 Algorithmic Lie Symmetry Analysis and Group Classication for Ordinary Dierential Equations Dmitry A. Lyakhov 1 1 Computational Sciences

More information

Parallelism in Structured Newton Computations

Parallelism in Structured Newton Computations Parallelism in Structured Newton Computations Thomas F Coleman and Wei u Department of Combinatorics and Optimization University of Waterloo Waterloo, Ontario, Canada N2L 3G1 E-mail: tfcoleman@uwaterlooca

More information

GENG2140, S2, 2012 Week 7: Curve fitting

GENG2140, S2, 2012 Week 7: Curve fitting GENG2140, S2, 2012 Week 7: Curve fitting Curve fitting is the process of constructing a curve, or mathematical function, f(x) that has the best fit to a series of data points Involves fitting lines and

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

Numerical methods for the Navier- Stokes equations

Numerical methods for the Navier- Stokes equations Numerical methods for the Navier- Stokes equations Hans Petter Langtangen 1,2 1 Center for Biomedical Computing, Simula Research Laboratory 2 Department of Informatics, University of Oslo Dec 6, 2012 Note:

More information

arxiv: v1 [astro-ph.ep] 21 Jan 2019

arxiv: v1 [astro-ph.ep] 21 Jan 2019 On the predictability of Galileo disposal orbits David J. Gondelach Roberto Armellin Alexander Wittig arxiv:1901.06947v1 [astro-ph.ep] 21 Jan 2019 Abstract The end-of-life disposal of Galileo satellites

More information

Numerical Methods in Informatics

Numerical Methods in Informatics Numerical Methods in Informatics Lecture 2, 30.09.2016: Nonlinear Equations in One Variable http://www.math.uzh.ch/binf4232 Tulin Kaman Institute of Mathematics, University of Zurich E-mail: tulin.kaman@math.uzh.ch

More information

Computational Methods in Plasma Physics

Computational Methods in Plasma Physics Computational Methods in Plasma Physics Richard Fitzpatrick Institute for Fusion Studies University of Texas at Austin Purpose of Talk Describe use of numerical methods to solve simple problem in plasma

More information

Review of Power Series

Review of Power Series Review of Power Series MATH 365 Ordinary Differential Equations J. Robert Buchanan Department of Mathematics Fall 2018 Introduction In addition to the techniques we have studied so far, we may use power

More information

Chapter 1 Error Analysis

Chapter 1 Error Analysis Chapter 1 Error Analysis Several sources of errors are important for numerical data processing: Experimental uncertainty: Input data from an experiment have a limited precision. Instead of the vector of

More information

HIGH-ORDER COMPUTATION AND NORMAL FORM ANALYSIS OF REPETITIVE SYSTEMS

HIGH-ORDER COMPUTATION AND NORMAL FORM ANALYSIS OF REPETITIVE SYSTEMS HIGH-ORDER COMPUTATION AND NORMAL FORM ANALYSIS OF REPETITIVE SYSTEMS Chapter of Physics of Particle Accelerators American Institute of Physics 249, 1991, M. Month (Ed.) M. Berz Department of Physics and

More information