Sensitivity analysis by adjoint Automatic Differentiation and Application

Size: px
Start display at page:

Download "Sensitivity analysis by adjoint Automatic Differentiation and Application"

Transcription

1 Sensitivity analysis by adjoint Automatic Differentiation and Application Anca Belme Massimiliano Martinelli Laurent Hascoët Valérie Pascual Alain Dervieux INRIA Sophia-Antipolis Project TROPICS ERCOFTAC Course on Uncertainty Management and Quantification in Industrial Analysis and Design, Munich, 3-4 mars Belme, Martinelli, Hascoët, Pascual, Dervieux Sensitivityanalysis by adjoint Automatic Differentiationand Application

2 Scope of the talk 1. Perturbation methods for uncertainties. 2. What is Automatic Differentiation. 3. Computing derivatives. 4. An application to CFD. 2 Belme, Martinelli, Hascoët, Pascual, Dervieux Sensitivityanalysis by adjoint Automatic Differentiationand Application

3 1. Perturbation methods for uncertainties The uncertainty management problem Consider a smooth functional j(c) = J(c, W(c)) c R n is the set of parameters W(c) R N is solution of the state equation Ψ(c,W) = 0, we assume that n N suppose now c Ω is a random parameter with a known probabilist law then j(c Ω ) is a random variable, the law of which we want to evaluate The Taylor-based perturbation approach The idea is to rely on the derivatives of j: j(c 0 + δc) = j(c 0 )+j (c 0 ) δc+ 1 2 j (c 0 ) δc δc Belme, Martinelli, Hascoët, Pascual, Dervieux Sensitivityanalysis by adjoint Automatic Differentiationand Application

4 Why second derivatives?(1) Perturbative methods for uncertainty propagation (Taylor expansion-based) Method of Moments: µ c mean of c Ω, σ 2 i variance of c Ω,i µ j mean of j(c Ω ), σ 2 j variance of j(c Ω ) µ j j(µ c )+ 1 2 i H ii σ 2 i σj 2 G 2 i σi i 2 H 2 ikσi 2 σk 2 i,k 4 Belme, Martinelli, Hascoët, Pascual, Dervieux Sensitivityanalysis by adjoint Automatic Differentiationand Application

5 Why second derivatives?(2) Perturbative methods for uncertainty propagation (Taylor expansion-based) Reduced order Taylor model j reduced (c 0 + δc) = j(c 0 )+j (c 0 ) δc+ 1 2 j (c 0 ) δc δc Evaluate the j reduced (c Ω ) by any sorting (Monte-Carlo,...) 5 Belme, Martinelli, Hascoët, Pascual, Dervieux Sensitivityanalysis by adjoint Automatic Differentiationand Application

6 Why second derivatives(3) Robust optimization Gradient-based methods for j robust (c) = j(c)+ε dj dc Gradient-free methods for j robust (c) = j(c)+ 1 2 i H ii σ 2 i Gradient-free methods for j robust (c) = j(c)+kσ 2 j Optimisation of adjoint-corrected functionals Gradient-based methods for j corr (c) = j(c) Ψ ex (c,w),π 6 Belme, Martinelli, Hascoët, Pascual, Dervieux Sensitivityanalysis by adjoint Automatic Differentiationand Application

7 2. What is Automatic Differentiation A computer code P can be considered as evaluating a function f depending of data X. PROGRAM P : a = bx + c Automatic Differentiation is a technique to evaluate analytically derivatives of the function f defined by a computer program P. PROGRAM P : ȧ = ḃx + bẋ + ċ To this end, Automatic Differentiation transforms P in a new program P, either before compiling, this is source transformation, or at compiling step (operator overloading). 7 Belme, Martinelli, Hascoët, Pascual, Dervieux Sensitivityanalysis by adjoint Automatic Differentiationand Application

8 2. Automatic Differentiation Direct/Tangent mode Tangent differentiated code computes f (X).Ẋ f(x) = f p f p 1... f 1 Ẏ = f (x).ẋ = f p(z p 1 ).f p 1(Z p 2 )......f 1(Z 0 ).Ẋ Each instruction is replaced by: - itself Z k 1 Z k = f k (Z k 1 ) - its derivative Z k 1 f k 1 (Z k 1) Computational cost factor: α T 4 Does not store intermediate variables Z 0 = X ; Z k = f k (Z k 1 ) 8 Belme, Martinelli, Hascoët, Pascual, Dervieux Sensitivityanalysis by adjoint Automatic Differentiationand Application

9 2. Automatic Differentiation Backward/Reverse mode Reverse differentiated code computes (f (X)) t.δj f(x) = f p f p 1... f 1 (X) X = f t 1(Z 0 ).f t 2(Z 1 ).f t 2(Z 1 )......f t p 1(Z p 2 ).f t p(z p 1 ).Ȳ Compute forward Z k = f k (Z k 1 ) s and store, then compute backward X. Stores intermediate variables. Computational cost factor: α R 5 9 Belme, Martinelli, Hascoët, Pascual, Dervieux Sensitivityanalysis by adjoint Automatic Differentiationand Application

10 2. Automatic Differentiation Reverse mode, when to use it f : R n R m Tangent mode delivers f (X).Ẋ, i.e. m scalar answers. Reverse mode delibers f t (X).Ȳ i.e. n scalar answers. For n m reverse is about n/m more efficient than tangent. In our case, m = 1 and n > 1. Reverse mode, analogy with adjoint state method In case of a functional depending on a state variable, the reverse mode automatically introduces a subset of f t s which constitutes the adjoint state. Reverse mode, case of a functional with state system The reverse code solves state and adjoint, and produces n scalar answers. The tangent code solves a perturbative state and produces 1 scalar answer. Divided diffferences also produce 1 scalar answer, but in less robust conditions due to the small parameter to fix. 10 Belme, Martinelli, Hascoët, Pascual, Dervieux Sensitivityanalysis by adjoint Automatic Differentiationand Application

11 The TAPENADE program differentiator TAPENADE ( lines of JAVA) transforms a FORTRAN, F95, ANSI C program into a FORTRAN, F95, ANSI C program which computes the derivative of the given FORTRAN, F95, ANSI C program. TAPENADE is organised around an intermediate step, the analysis and differentation of an abstract imperative language Belme, Martinelli, Hascoët, Pascual, Dervieux Sensitivityanalysis by adjoint Automatic Differentiationand Application

12 TAPENADE on-line 12 Belme, Martinelli, Hascoët, Pascual, Dervieux Sensitivityanalysis by adjoint Automatic Differentiationand Application

13 2. Automatic Differentiation The TAPENADE program differentiator, recent advances TAPENADE V3 takes into account user directives inserted into sources. Directives are used for optimising storage for reverse mode and are a memory of this optimisation available for new code versions. Directive II-LOOP allows for a more efficient reverse differentiation of a frequent class of parallel loops (ex. assembly loops). Directive NOCHECKPOINT can be used for optimal checkpointing in reverse differentiation. TAPENADE lets the user specify finely which procedure calls must be checkpointed or not (ex. time advancing loop). TAPENADE is optimised for successive reverse differentiations. 13 Belme, Martinelli, Hascoët, Pascual, Dervieux Sensitivityanalysis by adjoint Automatic Differentiationand Application

14 3. Computating of derivatives of a state-dependant functional The differentiation problem Consider a computer program computing the functional j(c) = J(c, W(c)) c R n is the set of parameters W(c) R N is solution of the state equation Ψ(c,W) = 0 W(c) is a steady-state solution obtained by explicit or implicit (i.e. with a linearised system) pseudo-time advancing techniques we want, using TAPENADE, to get a computer program computing the second derivatives d 2 j dc 2 = (H ii) 14 Belme, Martinelli, Hascoët, Pascual, Dervieux Sensitivityanalysis by adjoint Automatic Differentiationand Application

15 Flow solver: basic algorithm Initialize c,w 0 i = i+1 Compute Ψ i = Ψ(c,W i ) Compute δw i = F(Ψ i ) (implicit or explicit) functional(j,c) Update W i+1 = W i + δw i False Test Ψ i < ε True Compute j = J(c,W itrue ) 15 Belme, Martinelli, Hascoët, Pascual, Dervieux Sensitivityanalysis by adjoint Automatic Differentiationand Application

16 Differentiability of a fixed point For a given ε > 0, or large: unsteady Due to the test ending the loop, the loop may need itrue iterations for a parameter c and itrue+1 (or itrue 1) iterations for a c+δc extremely close to c. This shows that the above discrete functional j is only piecewise continuous or differentiable. Further, state W itrue depends on initial conditions of the solution algorithm, in a similar manner to the solution of an unsteady system. The whole algorithm should be differentiated and in reverse case, intermediate (unconverged) values of state W should be stored for backward adjoint solution. Lastly, this option assumes we differentiate the solution algorithm. Assuming ε = 0, or small: fixed point Now, by the implicit function theorem, functional W and j are differentiable. State W(c), unique solution of the implicit system, does not depend on initial conditions of solution algorithm (if convergent and sufficiently converged). In tangent case, the perturbative system should be sufficiently converged. In reverse case, converged solution of state is used in all iterations of adjoint, then we converge sufficiently adjoint. This option is chosen. 16 Belme, Martinelli, Hascoët, Pascual, Dervieux Sensitivityanalysis by adjoint Automatic Differentiationand Application

17 Do not differentiate a sophisticated solution algorithm Initialize c,w 0 i = i+1 Compute Ψ i = Ψ(c,W i ) Compute δw i = F(Ψ i ) (implicit or explicit) functional(j,c) Update W i+1 = W i + δw i False Test Ψ i < ε True Compute j = J(c,W ) 17 Belme, Martinelli, Hascoët, Pascual, Dervieux Sensitivityanalysis by adjoint Automatic Differentiationand Application

18 Separate system assembly and solution algorithm Initialize c,w 0 stateres(psi,c,w) i = i+1 Compute Ψ i = Ψ(c,W i ) Compute δw i = F(Ψ i ) (implicit or explicit) Update W i+1 = W i + δw i False Test Ψ i < ε True Compute j = J(c,W ) func(j,c,w) 18 Belme, Martinelli, Hascoët, Pascual, Dervieux Sensitivityanalysis by adjoint Automatic Differentiationand Application

19 Non-differentiated matrix-free iterative solver Assume we use a matrix-free fixed-point (FP) method (ex.: GMRES) for solving a linearised state systemax = b Keep not-differentiated the FP algorithm The FP algorithm for derivatives (state Gateaux-derivative, adjoint state) needs the corresponding matrix-by-vector products Matrix-by-vector products are computed by differentiated code (from the state residual evaluation routine, stateres(psi,c,w) ) An algebraic preconditioner (ex.: ILU) should be re-engineered. 19 Belme, Martinelli, Hascoët, Pascual, Dervieux Sensitivityanalysis by adjoint Automatic Differentiationand Application

20 First Derivatives: basic Tangent algorithm Solve Ψ(c,W) = 0 Solve Ψ W θ = Ψ c ċ solve_matrixfree_tan Compute J W θ + J W c 20 Belme, Martinelli, Hascoët, Pascual, Dervieux Sensitivityanalysis by adjoint Automatic Differentiationand Application

21 Non-differentiated matrix-free iterative solver(2) Example: GMRES communication for Ax = b Enter in GMRES an initial solution x 0 and a right-hand side b GMRES needs matvec: v Av GMRES needs precon: v M 1 v. For direct state Gateaux derivative ( ) Ψ b = ċ c ( ) Ψ Av = v W we use direct mode: stateres_dw_d stateres_dw_d( psi,( psid), c, W x w, wd ) Ψ Ψ x W Preconditioner is the one for state iterative solution. 21 Belme, Martinelli, Hascoët, Pascual, Dervieux Sensitivityanalysis by adjoint Automatic Differentiationand Application

22 First-order derivative: Tangent Mode Tangent differentiate stateres with c and w as input stateres( psi, c, w ) stateres_d( psi,psid, c, cd ċ, W Ẇ w, wd ) Ψ Ψ Input variables: c = c, w = W, cd = ċ, wd = Ẇ ( Ψ Output variables: psi = Ψ, psid = Ψ = c ) ċ+ ( ) Ψ Ẇ W Converging the matrix-free solver produces the perturbative state solution Ẇ sol. 22 Belme, Martinelli, Hascoët, Pascual, Dervieux Sensitivityanalysis by adjoint Automatic Differentiationand Application

23 First-order derivative: Tangent Mode Tangent differentiate func with c and w as input func( j, c, w ) func_d( j J,jḋ J Ẇ sol, c ċ, cd, W w, wd ) Input variables: c = c, w = W, cd = ċ, wd = Ẇ sol ( ) ( ) J J Output variables: j = J, jd = J = ċ+ Ẇ sol c W 23 Belme, Martinelli, Hascoët, Pascual, Dervieux Sensitivityanalysis by adjoint Automatic Differentiationand Application

24 First Derivative: Reverse algorithm Solve Ψ(c,W) = 0 Solve ( ) Ψ ( ) J Π = W W solve_matrixfree_rev ( ) dj = dc ( ) J c ( ) Ψ Π c 24 Belme, Martinelli, Hascoët, Pascual, Dervieux Sensitivityanalysis by adjoint Automatic Differentiationand Application

25 Non-differentiated matrix-free iterative solver(3) Example: GMRES communication for Ax = b Enter in GMRES an initial solution x 0 and a right-hand side b GMRES needs matvec: v Av GMRES needs precon: v M 1 v. For reverse adjoint derivation ( ) J b = W ( ) Ψ Av = v W we use backward mode: stateres_dw_b x stateres_dw_b( psi, psib, c, W w, Ψ wb) x) ( Ψ W Preconditioner is the transpose of the one for state iterative solution. 25 Belme, Martinelli, Hascoët, Pascual, Dervieux Sensitivityanalysis by adjoint Automatic Differentiationand Application

26 First-order derivative: Reverse Mode func( j, c, w ) J func_b( j, jb, c, J,cb c W w,wb W ) Input variables: c = c, w = W, jb = J Output variables: j = J, ( ) J cb = c = J c ( ) J wb = W = J W 26 Belme, Martinelli, Hascoët, Pascual, Dervieux Sensitivityanalysis by adjoint Automatic Differentiationand Application

27 First-order derivative: Reverse Mode stateres( psi, c, w ) Ψ stateres_b( psi, psib, c, Ψ,cb c W w,wb W ) Input variables: c = c, w = W, psib = Ψ Output variables: psi = Ψ, ( ) Ψ cb = c = Ψ c ( ) Ψ wb = W = Ψ W 27 Belme, Martinelli, Hascoët, Pascual, Dervieux Sensitivityanalysis by adjoint Automatic Differentiationand Application

28 Second derivative: Tangent-on-Tangent approach d 2 j dc i dc k = Π D 2 i,kψ+d 2 i,kj with Π solution of the adjoint system ( ) Ψ Π = W ( ) J W and D 2 i,k J = ( ) J c c e i e k + ( ) J W c e i θ k + ( J W c e k D 2 i,kψ = ( ) Ψ c c e i e k + ( ) Ψ W c e i θ k + W where θ k = dw dc k is the solution of the system Ψ dw = Ψ W dc k c e k ( Ψ c e k ) θ i + W ) θ i + W ( ) J W θ i ( Ψ W θ i θ k ) θ k 28 Belme, Martinelli, Hascoët, Pascual, Dervieux Sensitivityanalysis by adjoint Automatic Differentiationand Application

29 Second Derivatives: basic ToT algorithm Solve Ψ(c,W) = 0 Solve ( ) Ψ ( ) J Π = W W solve_matrixfree_adj i = 1,...,n Initialize e i i = 1,...,n k = i,...,n Solve Ψ W θ i = Ψ c e i solve_matrixfree_tan func_d_d Compute D 2 i,k J Compute D2 i,k Ψ stateres_d_d Compute d 2 j dc i dc k = D 2 i,kj Π D 2 i,kψ 29 Belme, Martinelli, Hascoët, Pascual, Dervieux Sensitivityanalysis by adjoint Automatic Differentiationand Application

30 Second derivative: Tangent-on-Tangent Mode stateres_d( psi,psid, c,cd, w,wd ) stateres_d_d( psi,psid Ψ Ψ,psidd Ψ e k θ k, c, cd0, e i cd, W w, wd0, θ i wd ) Input variables: c = c, cd = e i, w = W, wd = θ i, cd0 = e k, wd0 = θ ( ) ( ) k Ψ Ψ Output variables: psi = Ψ, psid = Ψ = e i + θ i c W psidd = ( ) Ψ c c e i e k + ( ) Ψ W c e i θ k + ( ) Ψ W c e k θ i + ( ) Ψ W W θ i θ k = D 2 i,kψ 30 Belme, Martinelli, Hascoët, Pascual, Dervieux Sensitivityanalysis by adjoint Automatic Differentiationand Application

31 Second derivative: Tangent-on-Tangent Mode func_d( j,jd, c,cd, w,wd ) func_d_d( j J,jḋ J,jdd J e k θ k, c, cd0, e i cd, W w, wd0, θ i wd ) Input variables: c = c, cd = e i, w = W, wd = θ i, cd0 = e k, wd0 = θ ( ) ( ) k J J Output variables: j = J, jd = J = e i + θ i c W jdd = ( ) J c c e i e k + ( ) J W c e i θ k + ( ) J W c e k θ i + ( ) J W W θ i θ k = D 2 i,kj 31 Belme, Martinelli, Hascoët, Pascual, Dervieux Sensitivityanalysis by adjoint Automatic Differentiationand Application

32 Second derivative: Tangent-on-Reverse c i ( ) j = c ( 2 j c 2 c ) e i = c [( Ψ c ( ) J e i + ( ) J θ i + c W c [( ) Ψ Π] θ i c ) Π] e i W with Π solution of the adjoint system ( ) Ψ Π = W ( ) J W ( ) Ψ λ i c θ i and λ i solution of the systems Ψ W θ i = Ψ c e i ( ) Ψ λ i = ( ) J e i + ( ) J θ i + W c W W W [( ) Ψ Π] e i [( ) Ψ Π] θ i c W W W 32 Belme, Martinelli, Hascoët, Pascual, Dervieux Sensitivityanalysis by adjoint Automatic Differentiationand Application

33 Second derivative: Tangent-on-Reverse c i ( ) j = c ( 2 ) j c 2 e i = J ci + ) λ i Ψ ci ( Ψ c with Π solution of the adjoint system ( ) Ψ ( ) J Π = W W θ i and λ i solution of the systems ( Ψ W Ψ W θ i = Ψ c e i ) λ i = J W i+ Ψ W i 33 Belme, Martinelli, Hascoët, Pascual, Dervieux Sensitivityanalysis by adjoint Automatic Differentiationand Application

34 Second Derivatives: basic ToR algorithm Solve Ψ(c,W) = 0 Solve ( ) Ψ ( ) J Π = W W solve_matrixfree_adj i = 1,...,n Initialize e i Solve Ψ W θ i = Ψ c e i solve_matrixfree_tan func_b_d Compute J c, J W Compute Ψ c, Ψ W stateres_b_d Solve ( ) Ψ λ i = J W Ψ W W solve_matrixfree_adj Compute c i ( ) j = J c Ψ c c ( ) Ψ λ i c stateres_dc_b 34 Belme, Martinelli, Hascoët, Pascual, Dervieux Sensitivityanalysis by adjoint Automatic Differentiationand Application

35 Full Hessian: ToT vs. ToR Common part ( ) Ψ ( ) J Adjoint state Π = W W n linear system to solve: Ψ dw = Ψ W dc i c e i Specific part We assume unitary cost for a single residual evaluation Ψ(c,W) ToT: computation of D 2 ik Ψ and n(n+1) D2 ikj = αt 2 (1 < α T < 4) 2 ( ) Ψ ToR: n (adjoint) linear system to solve: λ i = J W Ψ W W = n(n iter + α T )α R (1 < α R 5) Use ToT when n < 2α R(n iter + α T ) α 2 T 35 Belme, Martinelli, Hascoët, Pascual, Dervieux Sensitivityanalysis by adjoint Automatic Differentiationand Application

36 Cost for the full Hessian with different strategies 3e e+06 Cost for evaluating the full Hessian with different strategies ToT approach ToR approach ToT + ToR approach 2e+06 Runtime cost 1.5e+06 1e n Figure: We assumed n iter,r = n iter,t = 300 for the number of iterations needed to solve the linear systems (tangent and adjoint) and α T = 2, α R = 4 for the overhead associated with the Tangent- and Reverse-differentiation. 36 Belme, Martinelli, Hascoët, Pascual, Dervieux Sensitivityanalysis by adjoint Automatic Differentiationand Application

37 4. Application to a 3D-Euler software Numerics: Upwind vertex-centered finite-volume Implicit pseudo-time advancing with first-order Jacobian F77 37 Belme, Martinelli, Hascoët, Pascual, Dervieux Sensitivityanalysis by adjoint Automatic Differentiationand Application

38 Building the reduced quadratic model Nonlinear simulations Taylor 1st order (α=2.0, M=3) Drag Drag Mach Angle of attack 8 2 Mach Angle of attack Taylor 2nd order (α=2.0, M=3) Relative Difference: Nonlinear vs. Taylor 2nd order Drag Relative difference (%) Mach Angle of attack 8 2 Mach Angle of attack 38 Belme, Martinelli, Hascoët, Pascual, Dervieux Sensitivityanalysis by adjoint Automatic Differentiationand Application

39 3D Euler flow around SSBJ (1) 39 Belme, Martinelli, Hascoët, Pascual, Dervieux Sensitivityanalysis by adjoint Automatic Differentiationand Application

40 3D Euler flow around SSBJ (2): sensitivities of the drag coefficient Taylor 1st order (α=3.0, M=) Taylor 2nd order (α=3.0, M=) Drag Drag Mach Angle of attack 6 8 Mach Angle of attack Taylor 1st order (α=3.0, M=) Taylor 2nd order (α=3.0, M=) Drag Drag Mach Angle of attack 6 8 Mach Angle of attack 40 Belme, Martinelli, Hascoët, Pascual, Dervieux Sensitivityanalysis by adjoint Automatic Differentiationand Application

41 3D Euler flow around SSBJ (2): sensitivities of the drag coefficient Taylor 1st order (α=3.0, M=1.0) Taylor 2nd order (α=3.0, M=1.0) Drag Drag Mach Angle of attack 6 8 Mach Angle of attack Taylor 1st order (α=3.0, M=1.1) Taylor 2nd order (α=3.0, M=1.1) Drag Drag Mach Angle of attack Mach Angle of attack 41 Belme, Martinelli, Hascoët, Pascual, Dervieux Sensitivityanalysis by adjoint Automatic Differentiationand Application

42 3D Euler flow around SSBJ (2): sensitivities of the drag coefficient Taylor 1st order (α=3.0, M=1.2) Taylor 2nd order (α=3.0, M=1.2) Drag Drag Mach Angle of attack Mach Angle of attack Taylor 1st order (α=3.0, M=1.4) Taylor 2nd order (α=3.0, M=1.4) Drag Drag Mach Angle of attack Mach Angle of attack 42 Belme, Martinelli, Hascoët, Pascual, Dervieux Sensitivityanalysis by adjoint Automatic Differentiationand Application

43 3D Euler flow around SSBJ (2): sensitivities of the drag coefficient Taylor 1st order (α=3.0, M=1.6) Taylor 2nd order (α=3.0, M=1.6) Drag Drag Mach Angle of attack Mach Angle of attack 43 Belme, Martinelli, Hascoët, Pascual, Dervieux Sensitivityanalysis by adjoint Automatic Differentiationand Application

44 Comparing the reduced quadratic model with metamodels ( ) Metamodel Points Expectation Relative error Variance Relative error Radial Basis Function % % Kriging % % AD: First-order % % AD: Second-order % % AD steps Memory in Mb Flow solver First-order Jacobian + Block-diag. Precond. + work vectors First derivatives ILU(1) Precond. + GMRES(200) + differentiated vectors Second derivatives ILU(1) Precond. + GMRES(200) + differentiated vectors AD: CPU time in second RBF or KRG: CPU time in second Flow solver *8 Gradient 255 Hessian 278 Total ( ) M. Martinelli, R. Duvigneau, On the use of second-order derivative and metamodel-based Monte-Carlo for uncertainty estimation in aerodynamics, Computers and Fluids, Vol 37, No 6, Belme, Martinelli, Hascoët, Pascual, Dervieux Sensitivityanalysis by adjoint Automatic Differentiationand Application

45 Concluding remarks Synthesis: a non-black-box AD application Optimum use of modern iterative solvers. Avoid managing useless storage or recomputing in backward mode. First and second derivative architecture well identified. Validated by experiments. Future works Very large instationary state systems. Automated treatment of mpi. Functional involved in robust optimisation and their gradients. 45 Belme, Martinelli, Hascoët, Pascual, Dervieux Sensitivityanalysis by adjoint Automatic Differentiationand Application

Automatic Differentiation for Optimum Design, Applied to Sonic Boom Reduction

Automatic Differentiation for Optimum Design, Applied to Sonic Boom Reduction Automatic Differentiation for Optimum Design, Applied to Sonic Boom Reduction Laurent Hascoët, Mariano Vázquez, Alain Dervieux Laurent.Hascoet@sophia.inria.fr Tropics Project, INRIA Sophia-Antipolis AD

More information

Certification of Derivatives Computed by Automatic Differentiation

Certification of Derivatives Computed by Automatic Differentiation Certification of Derivatives Computed by Automatic Differentiation Mauricio Araya Polo & Laurent Hascoët Project TROPCS WSEAS, Cancún, México, May 13, 2005 1 Plan ntroduction (Background) Automatic Differentiation

More information

SAROD Conference, Hyderabad, december 2005 CONTINUOUS MESH ADAPTATION MODELS FOR CFD

SAROD Conference, Hyderabad, december 2005 CONTINUOUS MESH ADAPTATION MODELS FOR CFD 1 SAROD Conference, Hyderabad, december 2005 CONTINUOUS MESH ADAPTATION MODELS FOR CFD Bruno Koobus, 1,2 Laurent Hascoët, 1 Frédéric Alauzet, 3 Adrien Loseille, 3 Youssef Mesri, 1 Alain Dervieux 1 1 INRIA

More information

Efficient Hessian Calculation using Automatic Differentiation

Efficient Hessian Calculation using Automatic Differentiation 25th AIAA Applied Aerodynamics Conference, 25-28 June 2007, Miami Efficient Hessian Calculation using Automatic Differentiation Devendra P. Ghate and Michael B. Giles Oxford University Computing Laboratory,

More information

TOWARD THE SOLUTION OF KKT SYSTEMS IN AERODYNAMICAL SHAPE OPTIMISATION

TOWARD THE SOLUTION OF KKT SYSTEMS IN AERODYNAMICAL SHAPE OPTIMISATION CIRM, Marseille, 7-10 juillet 2003 1 TOWARD THE SOLUTION OF KKT SYSTEMS IN AERODYNAMICAL SHAPE OPTIMISATION Alain Dervieux, François Courty, INRIA, Sophia-Antipolis e-mail: alain.dervieux@sophia.inria.fr

More information

AD-based perturbation methods for uncertainties and errors. M. Martinelli*, A. Dervieux, L. Hascoët, V. Pascual and A. Belme

AD-based perturbation methods for uncertainties and errors. M. Martinelli*, A. Dervieux, L. Hascoët, V. Pascual and A. Belme Int. J. Engineering Systems Modelling and Simulation, Vol., Nos. 1/, 010 65 AD-based perturbation metods for uncertainties and errors M. Martinelli, A. Dervieux, L. Hascoët, V. Pascual and A. Belme Institut

More information

Airfoil shape optimization using adjoint method and automatic differentiation

Airfoil shape optimization using adjoint method and automatic differentiation Airfoil shape optimization using adjoint method and automatic differentiation Praveen. C praveen@math.tifrbng.res.in Tata Institute of Fundamental Research Center for Applicable Mathematics Bangalore 5665

More information

Module III: Partial differential equations and optimization

Module III: Partial differential equations and optimization Module III: Partial differential equations and optimization Martin Berggren Department of Information Technology Uppsala University Optimization for differential equations Content Martin Berggren (UU)

More information

STCE. Adjoint Code Design Patterns. Uwe Naumann. RWTH Aachen University, Germany. QuanTech Conference, London, April 2016

STCE. Adjoint Code Design Patterns. Uwe Naumann. RWTH Aachen University, Germany. QuanTech Conference, London, April 2016 Adjoint Code Design Patterns Uwe Naumann RWTH Aachen University, Germany QuanTech Conference, London, April 2016 Outline Why Adjoints? What Are Adjoints? Software Tool Support: dco/c++ Adjoint Code Design

More information

Is My CFD Mesh Adequate? A Quantitative Answer

Is My CFD Mesh Adequate? A Quantitative Answer Is My CFD Mesh Adequate? A Quantitative Answer Krzysztof J. Fidkowski Gas Dynamics Research Colloqium Aerospace Engineering Department University of Michigan January 26, 2011 K.J. Fidkowski (UM) GDRC 2011

More information

Derivatives for Time-Spectral Computational Fluid Dynamics using an Automatic Differentiation Adjoint

Derivatives for Time-Spectral Computational Fluid Dynamics using an Automatic Differentiation Adjoint Derivatives for Time-Spectral Computational Fluid Dynamics using an Automatic Differentiation Adjoint Charles A. Mader University of Toronto Institute for Aerospace Studies Toronto, Ontario, Canada Joaquim

More information

The Data-Dependence graph of Adjoint Codes

The Data-Dependence graph of Adjoint Codes The Data-Dependence graph of Adjoint Codes Laurent Hascoët INRIA Sophia-Antipolis November 19th, 2012 (INRIA Sophia-Antipolis) Data-Deps of Adjoints 19/11/2012 1 / 14 Data-Dependence graph of this talk

More information

A COUPLED-ADJOINT METHOD FOR HIGH-FIDELITY AERO-STRUCTURAL OPTIMIZATION

A COUPLED-ADJOINT METHOD FOR HIGH-FIDELITY AERO-STRUCTURAL OPTIMIZATION A COUPLED-ADJOINT METHOD FOR HIGH-FIDELITY AERO-STRUCTURAL OPTIMIZATION Joaquim Rafael Rost Ávila Martins Department of Aeronautics and Astronautics Stanford University Ph.D. Oral Examination, Stanford

More information

Tangent linear and adjoint models for variational data assimilation

Tangent linear and adjoint models for variational data assimilation Data Assimilation Training Course, Reading, -4 arch 4 Tangent linear and adjoint models for variational data assimilation Angela Benedetti with contributions from: arta Janisková, Philippe Lopez, Lars

More information

A Crash-Course on the Adjoint Method for Aerodynamic Shape Optimization

A Crash-Course on the Adjoint Method for Aerodynamic Shape Optimization A Crash-Course on the Adjoint Method for Aerodynamic Shape Optimization Juan J. Alonso Department of Aeronautics & Astronautics Stanford University jjalonso@stanford.edu Lecture 19 AA200b Applied Aerodynamics

More information

High Performance Nonlinear Solvers

High Performance Nonlinear Solvers What is a nonlinear system? High Performance Nonlinear Solvers Michael McCourt Division Argonne National Laboratory IIT Meshfree Seminar September 19, 2011 Every nonlinear system of equations can be described

More information

Adjoint approach to optimization

Adjoint approach to optimization Adjoint approach to optimization Praveen. C praveen@math.tifrbng.res.in Tata Institute of Fundamental Research Center for Applicable Mathematics Bangalore 560065 http://math.tifrbng.res.in Health, Safety

More information

Using AD to derive adjoints for large, legacy CFD solvers

Using AD to derive adjoints for large, legacy CFD solvers Using AD to derive adjoints for large, legacy CFD solvers J.-D. Müller Queen Mary, University of London collaborators: D. Jones, F. Christakpoulos, S. Xu, QMUL S. Bayyuk, ESI, Huntsville AL c Jens-Dominik

More information

Variational assimilation Practical considerations. Amos S. Lawless

Variational assimilation Practical considerations. Amos S. Lawless Variational assimilation Practical considerations Amos S. Lawless a.s.lawless@reading.ac.uk 4D-Var problem ] [ ] [ 2 2 min i i i n i i T i i i b T b h h J y R y B,,, n i i i i f subject to Minimization

More information

Uncertainty Quantification in Viscous Hypersonic Flows using Gradient Information and Surrogate Modeling

Uncertainty Quantification in Viscous Hypersonic Flows using Gradient Information and Surrogate Modeling Uncertainty Quantification in Viscous Hypersonic Flows using Gradient Information and Surrogate Modeling Brian A. Lockwood, Markus P. Rumpfkeil, Wataru Yamazaki, and Dimitri J. Mavriplis University of

More information

Implicit Solution of Viscous Aerodynamic Flows using the Discontinuous Galerkin Method

Implicit Solution of Viscous Aerodynamic Flows using the Discontinuous Galerkin Method Implicit Solution of Viscous Aerodynamic Flows using the Discontinuous Galerkin Method Per-Olof Persson and Jaime Peraire Massachusetts Institute of Technology 7th World Congress on Computational Mechanics

More information

A Fast, Parallel Potential Flow Solver

A Fast, Parallel Potential Flow Solver Advisor: Jaime Peraire December 16, 2012 Outline 1 Introduction to Potential FLow 2 The Boundary Element Method 3 The Fast Multipole Method 4 Discretization 5 Implementation 6 Results 7 Conclusions Why

More information

FOR many computational fluid dynamics (CFD) applications, engineers require information about multiple solution

FOR many computational fluid dynamics (CFD) applications, engineers require information about multiple solution AIAA Aviation 13-17 June 2016, Washington, D.C. 46th AIAA Fluid Dynamics Conference AIAA 2016-3809 Improved Functional-Based Error Estimation and Adaptation without Adjoints William C. Tyson *, Katarzyna

More information

Adjoint-Based Uncertainty Quantification and Sensitivity Analysis for Reactor Depletion Calculations

Adjoint-Based Uncertainty Quantification and Sensitivity Analysis for Reactor Depletion Calculations Adjoint-Based Uncertainty Quantification and Sensitivity Analysis for Reactor Depletion Calculations Hayes F. Stripling 1 Marvin L. Adams 1 Mihai Anitescu 2 1 Department of Nuclear Engineering, Texas A&M

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

Edwin van der Weide and Magnus Svärd. I. Background information for the SBP-SAT scheme

Edwin van der Weide and Magnus Svärd. I. Background information for the SBP-SAT scheme Edwin van der Weide and Magnus Svärd I. Background information for the SBP-SAT scheme As is well-known, stability of a numerical scheme is a key property for a robust and accurate numerical solution. Proving

More information

5. FVM discretization and Solution Procedure

5. FVM discretization and Solution Procedure 5. FVM discretization and Solution Procedure 1. The fluid domain is divided into a finite number of control volumes (cells of a computational grid). 2. Integral form of the conservation equations are discretized

More information

AN EVALUATION SCHEME FOR THE UNCERTAINTY ANALYSIS OF A CAPTIVE TRAJECTORY SYSTEM

AN EVALUATION SCHEME FOR THE UNCERTAINTY ANALYSIS OF A CAPTIVE TRAJECTORY SYSTEM 24th INTERNATIONAL CONGRESS OF THE AERONAUTICAL SCIENCES AN EVALUATION SCHEME FOR THE UNCERTAINTY ANALYSIS OF A CAPTIVE TRAJECTORY SYSTEM Sean Tuling Defencetek, CSIR Keywords: Uncertainty Analysis, CTS

More information

Chapter Two: Numerical Methods for Elliptic PDEs. 1 Finite Difference Methods for Elliptic PDEs

Chapter Two: Numerical Methods for Elliptic PDEs. 1 Finite Difference Methods for Elliptic PDEs Chapter Two: Numerical Methods for Elliptic PDEs Finite Difference Methods for Elliptic PDEs.. Finite difference scheme. We consider a simple example u := subject to Dirichlet boundary conditions ( ) u

More information

Discrete and continuous adjoint method for compressible CFD J. Peter ONERA

Discrete and continuous adjoint method for compressible CFD J. Peter ONERA Discrete and continuous adjoint method for compressible CFD J. Peter ONERA J. Peter 1 1 ONERA DMFN October 2, 2014 J. Peter (ONERA DMFN) Adjoint method for compressible CFD October 2, 2014 1 / 60 Outline

More information

Improving the Verification and Validation Process

Improving the Verification and Validation Process Improving the Verification and Validation Process Mike Fagan Rice University Dave Higdon Los Alamos National Laboratory Notes to Audience I will use the much shorter VnV abbreviation, rather than repeat

More information

Adjoint code development and optimization using automatic differentiation (AD)

Adjoint code development and optimization using automatic differentiation (AD) Adjoint code development and optimization using automatic differentiation (AD) Praveen. C Computational and Theoretical Fluid Dynamics Division National Aerospace Laboratories Bangalore - 560 037 CTFD

More information

Estimating functional uncertainty using polynomial chaos and adjoint equations

Estimating functional uncertainty using polynomial chaos and adjoint equations 0. Estimating functional uncertainty using polynomial chaos and adjoint equations February 24, 2011 1 Florida State University, Tallahassee, Florida, Usa 2 Moscow Institute of Physics and Technology, Moscow,

More information

Partial Differential Equations

Partial Differential Equations Partial Differential Equations Introduction Deng Li Discretization Methods Chunfang Chen, Danny Thorne, Adam Zornes CS521 Feb.,7, 2006 What do You Stand For? A PDE is a Partial Differential Equation This

More information

Algorithmic Differentiation of Numerical Methods: Tangent and Adjoint Solvers for Parameterized Systems of Nonlinear Equations

Algorithmic Differentiation of Numerical Methods: Tangent and Adjoint Solvers for Parameterized Systems of Nonlinear Equations Algorithmic Differentiation of Numerical Methods: Tangent and Adjoint Solvers for Parameterized Systems of Nonlinear Equations UWE NAUMANN, JOHANNES LOTZ, KLAUS LEPPKES, and MARKUS TOWARA, RWTH Aachen

More information

Linear Regression and Its Applications

Linear Regression and Its Applications Linear Regression and Its Applications Predrag Radivojac October 13, 2014 Given a data set D = {(x i, y i )} n the objective is to learn the relationship between features and the target. We usually start

More information

First, Second, and Third Order Finite-Volume Schemes for Diffusion

First, Second, and Third Order Finite-Volume Schemes for Diffusion First, Second, and Third Order Finite-Volume Schemes for Diffusion Hiro Nishikawa 51st AIAA Aerospace Sciences Meeting, January 10, 2013 Supported by ARO (PM: Dr. Frederick Ferguson), NASA, Software Cradle.

More information

Numerical simulation of the Gross-Pitaevskii equation by pseudo-spectral and finite element methods comparison of GPS code and FreeFem++

Numerical simulation of the Gross-Pitaevskii equation by pseudo-spectral and finite element methods comparison of GPS code and FreeFem++ . p.1/13 10 ec. 2014, LJLL, Paris FreeFem++ workshop : BECASIM session Numerical simulation of the Gross-Pitaevskii equation by pseudo-spectral and finite element methods comparison of GPS code and FreeFem++

More information

Intro to Automatic Differentiation

Intro to Automatic Differentiation Intro to Automatic Differentiation Thomas Kaminski (http://fastopt.com) Thanks to: Simon Blessing (FastOpt), Ralf Giering (FastOpt), Nadine Gobron (JRC), Wolfgang Knorr (QUEST), Thomas Lavergne (Met.No),

More information

Multigrid solvers for equations arising in implicit MHD simulations

Multigrid solvers for equations arising in implicit MHD simulations Multigrid solvers for equations arising in implicit MHD simulations smoothing Finest Grid Mark F. Adams Department of Applied Physics & Applied Mathematics Columbia University Ravi Samtaney PPPL Achi Brandt

More information

Basic Aspects of Discretization

Basic Aspects of Discretization Basic Aspects of Discretization Solution Methods Singularity Methods Panel method and VLM Simple, very powerful, can be used on PC Nonlinear flow effects were excluded Direct numerical Methods (Field Methods)

More information

Organization. I MCMC discussion. I project talks. I Lecture.

Organization. I MCMC discussion. I project talks. I Lecture. Organization I MCMC discussion I project talks. I Lecture. Content I Uncertainty Propagation Overview I Forward-Backward with an Ensemble I Model Reduction (Intro) Uncertainty Propagation in Causal Systems

More information

Breaking Computational Barriers: Multi-GPU High-Order RBF Kernel Problems with Millions of Points

Breaking Computational Barriers: Multi-GPU High-Order RBF Kernel Problems with Millions of Points Breaking Computational Barriers: Multi-GPU High-Order RBF Kernel Problems with Millions of Points Michael Griebel Christian Rieger Peter Zaspel Institute for Numerical Simulation Rheinische Friedrich-Wilhelms-Universität

More information

FEniCS Course Lecture 13: Introduction to dolfin-adjoint. Contributors Simon Funke Patrick Farrell Marie E. Rognes

FEniCS Course Lecture 13: Introduction to dolfin-adjoint. Contributors Simon Funke Patrick Farrell Marie E. Rognes FEniCS Course Lecture 13: Introduction to dolfin-adjoint Contributors Simon Funke Patrick Farrell Marie E. Rognes 1 / 25 dolfin adjoint automatic adjoint models for FEniCS P. E. Farrell, S. W. Funke, D.

More information

Automatic Differentiation of programs and its applications to Scientific Computing

Automatic Differentiation of programs and its applications to Scientific Computing Automatic Differentiation of programs and its applications to Scientific Computing Laurent Hascoët INRIA Sophia-Antipolis, France http://www-sop.inria.fr/tropics September 2010 Laurent Hascoët (INRIA)

More information

Uncertainty Quantification in Viscous Hypersonic Flows using Gradient Information and Surrogate Modeling

Uncertainty Quantification in Viscous Hypersonic Flows using Gradient Information and Surrogate Modeling Uncertainty Quantification in Viscous Hypersonic Flows using Gradient Information and Surrogate Modeling Brian A. Lockwood, Markus P. Rumpfkeil, Wataru Yamazaki and Dimitri J. Mavriplis Mechanical Engineering

More information

Copyright 2003 by the American Institute of Aeronautics and Astronautics Inc. All rights reserved

Copyright 2003 by the American Institute of Aeronautics and Astronautics Inc. All rights reserved 1 ISABE29-1225 COMPUTATION OF SECOND-ORDER SENSITIVITIES OF THE TOTAL PRESSURE LOSSES FUNCTIONAL IN CASCADE FLOWS T. Zervogiannis, D.I. Papadimitriou and K.C. Giannakoglou National Technical University

More information

Support Vector Regression (SVR) Descriptions of SVR in this discussion follow that in Refs. (2, 6, 7, 8, 9). The literature

Support Vector Regression (SVR) Descriptions of SVR in this discussion follow that in Refs. (2, 6, 7, 8, 9). The literature Support Vector Regression (SVR) Descriptions of SVR in this discussion follow that in Refs. (2, 6, 7, 8, 9). The literature suggests the design variables should be normalized to a range of [-1,1] or [0,1].

More information

IMPLEMENTATION OF AN ADJOINT THERMAL SOLVER FOR INVERSE PROBLEMS

IMPLEMENTATION OF AN ADJOINT THERMAL SOLVER FOR INVERSE PROBLEMS Paper ID: ETC217-336 Proceedings of 12th European Conference on Turbomachinery Fluid dynamics & Thermodynamics ETC12, April 3-7, 217; Stockholm, Sweden IMPLEMENTATION OF AN ADJOINT THERMAL SOLVER FOR INVERSE

More information

TAU Solver Improvement [Implicit methods]

TAU Solver Improvement [Implicit methods] TAU Solver Improvement [Implicit methods] Richard Dwight Megadesign 23-24 May 2007 Folie 1 > Vortrag > Autor Outline Motivation (convergence acceleration to steady state, fast unsteady) Implicit methods

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

An Active Set Strategy for Solving Optimization Problems with up to 200,000,000 Nonlinear Constraints

An Active Set Strategy for Solving Optimization Problems with up to 200,000,000 Nonlinear Constraints An Active Set Strategy for Solving Optimization Problems with up to 200,000,000 Nonlinear Constraints Klaus Schittkowski Department of Computer Science, University of Bayreuth 95440 Bayreuth, Germany e-mail:

More information

Controlled Diffusions and Hamilton-Jacobi Bellman Equations

Controlled Diffusions and Hamilton-Jacobi Bellman Equations Controlled Diffusions and Hamilton-Jacobi Bellman Equations Emo Todorov Applied Mathematics and Computer Science & Engineering University of Washington Winter 2014 Emo Todorov (UW) AMATH/CSE 579, Winter

More information

PHYS 410/555 Computational Physics Solution of Non Linear Equations (a.k.a. Root Finding) (Reference Numerical Recipes, 9.0, 9.1, 9.

PHYS 410/555 Computational Physics Solution of Non Linear Equations (a.k.a. Root Finding) (Reference Numerical Recipes, 9.0, 9.1, 9. PHYS 410/555 Computational Physics Solution of Non Linear Equations (a.k.a. Root Finding) (Reference Numerical Recipes, 9.0, 9.1, 9.4) We will consider two cases 1. f(x) = 0 1-dimensional 2. f(x) = 0 d-dimensional

More information

Solving Ax = b, an overview. Program

Solving Ax = b, an overview. Program Numerical Linear Algebra Improving iterative solvers: preconditioning, deflation, numerical software and parallelisation Gerard Sleijpen and Martin van Gijzen November 29, 27 Solving Ax = b, an overview

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

Lecture 1: Basics Concepts

Lecture 1: Basics Concepts National Technical University of Athens School of Chemical Engineering Department II: Process Analysis and Plant Design Lecture 1: Basics Concepts Instructor: Α. Kokossis Laboratory teaching staff: Α.

More information

Review for Exam 2 Ben Wang and Mark Styczynski

Review for Exam 2 Ben Wang and Mark Styczynski Review for Exam Ben Wang and Mark Styczynski This is a rough approximation of what we went over in the review session. This is actually more detailed in portions than what we went over. Also, please note

More information

Lie Groups for 2D and 3D Transformations

Lie Groups for 2D and 3D Transformations Lie Groups for 2D and 3D Transformations Ethan Eade Updated May 20, 2017 * 1 Introduction This document derives useful formulae for working with the Lie groups that represent transformations in 2D and

More information

MATLAB Solution of Flow and Heat Transfer through a Porous Cooling Channel and the Conjugate Heat Transfer in the Surrounding Wall

MATLAB Solution of Flow and Heat Transfer through a Porous Cooling Channel and the Conjugate Heat Transfer in the Surrounding Wall MATLAB Solution of Flow and Heat Transfer through a Porous Cooling Channel and the Conjugate Heat Transfer in the Surrounding Wall James Cherry, Mehmet Sözen Grand Valley State University, cherryj1@gmail.com,

More information

SMAI-JCM SMAI Journal of Computational Mathematics. Parallel reverse time integration and reduced order models

SMAI-JCM SMAI Journal of Computational Mathematics. Parallel reverse time integration and reduced order models SMAI-JCM SMAI Journal of Computational Mathematics Parallel reverse time integration and reduced order models Bijan Mohammadi Volume 1 (215), p. 5-28.

More information

Model Calibration under Uncertainty: Matching Distribution Information

Model Calibration under Uncertainty: Matching Distribution Information Model Calibration under Uncertainty: Matching Distribution Information Laura P. Swiler, Brian M. Adams, and Michael S. Eldred September 11, 008 AIAA Multidisciplinary Analysis and Optimization Conference

More information

Feedback Control of Aerodynamic Flows

Feedback Control of Aerodynamic Flows 44th AIAA Aerospace Sciences Meeting and Exhibit 9-12 January 26, Reno, Nevada AIAA 26-843 44th AIAA Aerospace Sciences Meeting and Exhibit, Reno, Nevada, 9 12 Jan, 26. Feedback Control of Aerodynamic

More information

Newton s Method and Efficient, Robust Variants

Newton s Method and Efficient, Robust Variants Newton s Method and Efficient, Robust Variants Philipp Birken University of Kassel (SFB/TRR 30) Soon: University of Lund October 7th 2013 Efficient solution of large systems of non-linear PDEs in science

More information

Motion Estimation (I) Ce Liu Microsoft Research New England

Motion Estimation (I) Ce Liu Microsoft Research New England Motion Estimation (I) Ce Liu celiu@microsoft.com Microsoft Research New England We live in a moving world Perceiving, understanding and predicting motion is an important part of our daily lives Motion

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

Application of a Non-Linear Frequency Domain Solver to the Euler and Navier-Stokes Equations

Application of a Non-Linear Frequency Domain Solver to the Euler and Navier-Stokes Equations Application of a Non-Linear Frequency Domain Solver to the Euler and Navier-Stokes Equations Matthew McMullen and Antony Jameson and Juan J. Alonso Dept. of Aeronautics & Astronautics Stanford University

More information

Nested Differentiation and Symmetric Hessian Graphs with ADTAGEO

Nested Differentiation and Symmetric Hessian Graphs with ADTAGEO Nested Differentiation and Symmetric Hessian Graphs with ADTAGEO ADjoints and TAngents by Graph Elimination Ordering Jan Riehme Andreas Griewank Institute for Applied Mathematics Humboldt Universität zu

More information

Effects of the Jacobian Evaluation on Direct Solutions of the Euler Equations

Effects of the Jacobian Evaluation on Direct Solutions of the Euler Equations Middle East Technical University Aerospace Engineering Department Effects of the Jacobian Evaluation on Direct Solutions of the Euler Equations by Ömer Onur Supervisor: Assoc. Prof. Dr. Sinan Eyi Outline

More information

Numerical Methods for Large-Scale Nonlinear Systems

Numerical Methods for Large-Scale Nonlinear Systems Numerical Methods for Large-Scale Nonlinear Systems Handouts by Ronald H.W. Hoppe following the monograph P. Deuflhard Newton Methods for Nonlinear Problems Springer, Berlin-Heidelberg-New York, 2004 Num.

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

DISCRETE AND CONTINUOUS ADJOINT METHODS IN AERODYNAMIC ROBUST DESIGN PROBLEMS

DISCRETE AND CONTINUOUS ADJOINT METHODS IN AERODYNAMIC ROBUST DESIGN PROBLEMS CFD and OPTIMIZATION 011 An ECCOMAS Thematic Conference 3-5 May 011, Antalya TURKEY DISCRETE AND CONTINUOUS ADJOINT METHODS IN AERODYNAMIC ROBUST DESIGN PROBLEMS Evangelos M. Papoutsis-Kiachagias, Dimitrios

More information

Motion Estimation (I)

Motion Estimation (I) Motion Estimation (I) Ce Liu celiu@microsoft.com Microsoft Research New England We live in a moving world Perceiving, understanding and predicting motion is an important part of our daily lives Motion

More information

MODELING OF CONCRETE MATERIALS AND STRUCTURES. Kaspar Willam. Class Meeting #5: Integration of Constitutive Equations

MODELING OF CONCRETE MATERIALS AND STRUCTURES. Kaspar Willam. Class Meeting #5: Integration of Constitutive Equations MODELING OF CONCRETE MATERIALS AND STRUCTURES Kaspar Willam University of Colorado at Boulder Class Meeting #5: Integration of Constitutive Equations Structural Equilibrium: Incremental Tangent Stiffness

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

Newton-Krylov-Schwarz Method for a Spherical Shallow Water Model

Newton-Krylov-Schwarz Method for a Spherical Shallow Water Model Newton-Krylov-Schwarz Method for a Spherical Shallow Water Model Chao Yang 1 and Xiao-Chuan Cai 2 1 Institute of Software, Chinese Academy of Sciences, Beijing 100190, P. R. China, yang@mail.rdcps.ac.cn

More information

Method 1: Geometric Error Optimization

Method 1: Geometric Error Optimization Method 1: Geometric Error Optimization we need to encode the constraints ŷ i F ˆx i = 0, rank F = 2 idea: reconstruct 3D point via equivalent projection matrices and use reprojection error equivalent projection

More information

11 a 12 a 21 a 11 a 22 a 12 a 21. (C.11) A = The determinant of a product of two matrices is given by AB = A B 1 1 = (C.13) and similarly.

11 a 12 a 21 a 11 a 22 a 12 a 21. (C.11) A = The determinant of a product of two matrices is given by AB = A B 1 1 = (C.13) and similarly. C PROPERTIES OF MATRICES 697 to whether the permutation i 1 i 2 i N is even or odd, respectively Note that I =1 Thus, for a 2 2 matrix, the determinant takes the form A = a 11 a 12 = a a 21 a 11 a 22 a

More information

1. Nonlinear Equations. This lecture note excerpted parts from Michael Heath and Max Gunzburger. f(x) = 0

1. Nonlinear Equations. This lecture note excerpted parts from Michael Heath and Max Gunzburger. f(x) = 0 Numerical Analysis 1 1. Nonlinear Equations This lecture note excerpted parts from Michael Heath and Max Gunzburger. Given function f, we seek value x for which where f : D R n R n is nonlinear. f(x) =

More information

Numerical Methods I Solving Nonlinear Equations

Numerical Methods I Solving Nonlinear Equations Numerical Methods I Solving Nonlinear Equations Aleksandar Donev Courant Institute, NYU 1 donev@courant.nyu.edu 1 MATH-GA 2011.003 / CSCI-GA 2945.003, Fall 2014 October 16th, 2014 A. Donev (Courant Institute)

More information

MATH529 Fundamentals of Optimization Unconstrained Optimization II

MATH529 Fundamentals of Optimization Unconstrained Optimization II MATH529 Fundamentals of Optimization Unconstrained Optimization II Marco A. Montes de Oca Mathematical Sciences, University of Delaware, USA 1 / 31 Recap 2 / 31 Example Find the local and global minimizers

More information

CHAPTER 10: Numerical Methods for DAEs

CHAPTER 10: Numerical Methods for DAEs CHAPTER 10: Numerical Methods for DAEs Numerical approaches for the solution of DAEs divide roughly into two classes: 1. direct discretization 2. reformulation (index reduction) plus discretization Direct

More information

FAS and Solver Performance

FAS and Solver Performance FAS and Solver Performance Matthew Knepley Mathematics and Computer Science Division Argonne National Laboratory Fall AMS Central Section Meeting Chicago, IL Oct 05 06, 2007 M. Knepley (ANL) FAS AMS 07

More information

Lecture 8: Fast Linear Solvers (Part 7)

Lecture 8: Fast Linear Solvers (Part 7) Lecture 8: Fast Linear Solvers (Part 7) 1 Modified Gram-Schmidt Process with Reorthogonalization Test Reorthogonalization If Av k 2 + δ v k+1 2 = Av k 2 to working precision. δ = 10 3 2 Householder Arnoldi

More information

Iterative Solvers in the Finite Element Solution of Transient Heat Conduction

Iterative Solvers in the Finite Element Solution of Transient Heat Conduction Iterative Solvers in the Finite Element Solution of Transient Heat Conduction Mile R. Vuji~i} PhD student Steve G.R. Brown Senior Lecturer Materials Research Centre School of Engineering University of

More information

Numerically Solving Partial Differential Equations

Numerically Solving Partial Differential Equations Numerically Solving Partial Differential Equations Michael Lavell Department of Applied Mathematics and Statistics Abstract The physics describing the fundamental principles of fluid dynamics can be written

More information

Large Steps in Cloth Simulation. Safeer C Sushil Kumar Meena Guide: Prof. Parag Chaudhuri

Large Steps in Cloth Simulation. Safeer C Sushil Kumar Meena Guide: Prof. Parag Chaudhuri Large Steps in Cloth Simulation Safeer C Sushil Kumar Meena Guide: Prof. Parag Chaudhuri Introduction Cloth modeling a challenging problem. Phenomena to be considered Stretch, shear, bend of cloth Interaction

More information

x n+1 = x n f(x n) f (x n ), n 0.

x n+1 = x n f(x n) f (x n ), n 0. 1. Nonlinear Equations Given scalar equation, f(x) = 0, (a) Describe I) Newtons Method, II) Secant Method for approximating the solution. (b) State sufficient conditions for Newton and Secant to converge.

More information

Linear Solvers. Andrew Hazel

Linear Solvers. Andrew Hazel Linear Solvers Andrew Hazel Introduction Thus far we have talked about the formulation and discretisation of physical problems...... and stopped when we got to a discrete linear system of equations. Introduction

More information

A high-order discontinuous Galerkin solver for 3D aerodynamic turbulent flows

A high-order discontinuous Galerkin solver for 3D aerodynamic turbulent flows A high-order discontinuous Galerkin solver for 3D aerodynamic turbulent flows F. Bassi, A. Crivellini, D. A. Di Pietro, S. Rebay Dipartimento di Ingegneria Industriale, Università di Bergamo CERMICS-ENPC

More information

CHAPTER 1. Introduction

CHAPTER 1. Introduction CHAPTER 1 Introduction Linear geometric control theory was initiated in the beginning of the 1970 s, see for example, [1, 7]. A good summary of the subject is the book by Wonham [17]. The term geometric

More information

New Streamfunction Approach for Magnetohydrodynamics

New Streamfunction Approach for Magnetohydrodynamics New Streamfunction Approac for Magnetoydrodynamics Kab Seo Kang Brooaven National Laboratory, Computational Science Center, Building 63, Room, Upton NY 973, USA. sang@bnl.gov Summary. We apply te finite

More information

Review and Unification of Methods for Computing Derivatives of Multidisciplinary Systems

Review and Unification of Methods for Computing Derivatives of Multidisciplinary Systems 53rd AAA/ASME/ASCE/AHS/ASC Structures, Structural Dynamics and Materials Conference2th A 23-26 April 212, Honolulu, Hawaii AAA 212-1589 Review and Unification of Methods for Computing Derivatives of

More information

ROBUST ESTIMATOR FOR MULTIPLE INLIER STRUCTURES

ROBUST ESTIMATOR FOR MULTIPLE INLIER STRUCTURES ROBUST ESTIMATOR FOR MULTIPLE INLIER STRUCTURES Xiang Yang (1) and Peter Meer (2) (1) Dept. of Mechanical and Aerospace Engineering (2) Dept. of Electrical and Computer Engineering Rutgers University,

More information

RECENT DEVELOPMENTS IN COMPUTATIONAL REACTOR ANALYSIS

RECENT DEVELOPMENTS IN COMPUTATIONAL REACTOR ANALYSIS RECENT DEVELOPMENTS IN COMPUTATIONAL REACTOR ANALYSIS Dean Wang April 30, 2015 24.505 Nuclear Reactor Physics Outline 2 Introduction and Background Coupled T-H/Neutronics Safety Analysis Numerical schemes

More information

Penalty and Barrier Methods General classical constrained minimization problem minimize f(x) subject to g(x) 0 h(x) =0 Penalty methods are motivated by the desire to use unconstrained optimization techniques

More information

The Derivative. Appendix B. B.1 The Derivative of f. Mappings from IR to IR

The Derivative. Appendix B. B.1 The Derivative of f. Mappings from IR to IR Appendix B The Derivative B.1 The Derivative of f In this chapter, we give a short summary of the derivative. Specifically, we want to compare/contrast how the derivative appears for functions whose domain

More information

Logistic Map, Euler & Runge-Kutta Method and Lotka-Volterra Equations

Logistic Map, Euler & Runge-Kutta Method and Lotka-Volterra Equations Logistic Map, Euler & Runge-Kutta Method and Lotka-Volterra Equations S. Y. Ha and J. Park Department of Mathematical Sciences Seoul National University Sep 23, 2013 Contents 1 Logistic Map 2 Euler and

More information

c 2013 Society for Industrial and Applied Mathematics

c 2013 Society for Industrial and Applied Mathematics SIAM J. SCI. COMPUT. Vol. 35, No. 4, pp. C369 C393 c 2013 Society for Industrial and Applied Mathematics AUTOMATED DERIVATION OF THE ADJOINT OF HIGH-LEVEL TRANSIENT FINITE ELEMENT PROGRAMS P. E. FARRELL,

More information

Active Flutter Control using an Adjoint Method

Active Flutter Control using an Adjoint Method 44th AIAA Aerospace Sciences Meeting and Exhibit 9-12 January 26, Reno, Nevada AIAA 26-844 44th AIAA Aerospace Sciences Meeting and Exhibit, Reno, Nevada, 9 12 Jan, 26. Active Flutter Control using an

More information