Simulation gyrocinétique des plasmas de fusion magnétique

Size: px
Start display at page:

Download "Simulation gyrocinétique des plasmas de fusion magnétique"

Transcription

1 Simulation gyrocinétique des plasmas de fusion magnétique IRMA, Université de Strasbourg & CNRS Calvi project-team INRIA Nancy Grand Est Collaborators: J.P. Braeunig, N. Crouseilles, M. Mehrenberger, T. Respaud (CALVI) V. Grandgirard, G. Latu (CEA Cadarache) IHP, Paris, 5 November 2010

2 Outline The physics context: magnetic fusion and ITER Specific issues linked to geometry and gyrokinetic equation Semi-Lagrangian Vlasov simulations Conservative semi-lagrangian method

3 The ITER project The Physics context ITER being built in France: Several new research actions. INRIA Large scale initiative on magnetic fusion. Involve applied mathematicians and computer scientists in ITER. Mathematical understanding and development of reduced models Gyrokinetic simulations: GYSELA (CEA+Strasbourg) MHD simulations: JOREK (CEA+Bordeaux+Nice) Inovative numerical methods: Asymptotic Preserving, geometric.. Plasma control: EQUINOXE (CEA+Nice)

4 Turbulent transport in magnetized plasma Plasma not very collisional and far from fluid state Kinetic description necessary. Fluid and kinetic simulations of turbulent transport yield very different results. Vlasov (6D espace des phases) coupled to Maxwell or Poisson f t + v xf + q m (E + v B) v f = 0. Toroidal geometry

5 The gyrokinetic model The Vlasov-Poisson gyrokinetic model reads f t + dx dt xf + dv f = 0, dt v with B dx dt B dv dt = b J(φ) + 1 q (mv 2 b + µb B) + V B = (B + m q V b) ( µ m B + q m J(φ)) and B = B + m q V b b. The gyroaverage operator J transforms the guiding center distribution to the distribution at the particle position which allows to take into account the finite Larmor radius effects.

6 Conservativity The Physics context We have the relations (B dx dt ) = (b J(φ)) + 1 (b µ B) q On the other hand = J(φ) b + µ q B b (B dv v dt ) = b (µ B + J(φ)). q Hence the phase-space divergence vanishes, which leads to the conservatity.

7 Numerical solution of the gyrokinetic model Difficulties: defined in phase-space (5D). Appearance of small scales Two approaches Full f. The gyrokinetic equation is solved for the full distribution function. δf. The perturbation with respect to the equilibrium function is solved, involving in some cases linearized equations. Two types of numerical methods: Particle methods: often preferred for higher dimensions. Often good qualitative results at lower cost. Numerical noise and slow convergence difficult to get precise results in some situations. Methods based on phase-space grids: Good grid resolution necessary for qualitatively correct results. No numerical noise, but diffusion. Easier to parallelize on a large number of processors.

8 The classical backward semi-lagrangian Method f conserved along characteristics Find the origin of the characteristics ending at the grid points Interpolate old value at origin of characteristics from known grid values High order interpolation needed Typical interpolation schemes. Cubic spline (Cheng-Knorr) Cubic Hermite with derivative transport (Nakamura-Yabe)

9 A history of semi-lagrangian schemes for the Vlasov equation Cheng-Knorr (JCP 1976): split method for 1D Vlasov-Poisson ES-Roche-Bertrand-Ghizzo (JCP 1998) : general semi-lagrangian framework for Vlasov type equations. Nakamura-Yabe (CPC 1999): CIP semi-lagrangian scheme with Hermite interpolation. Filbet-ES-Bertrand (JCP 2001): PFC semi-lagrangian positive and conservative with Lagrange interpolation. Nakamura-Tanaka-Yabe-Takizawa (JCP 2001): Conservative 1D split CIP semi-lagrangian. N. Besse - ES (JCP 2003) : SL schemes on unstructured grids. Crouseilles-Respaud-ES (CPC 2009) : Forward SL method. Crouseilles-Mehrenberger-ES (JCP 2010): conservative semi-lagrangian spline PSM + new classes of positive filters. Qiu-Christlieb (JCP 2010): conservative SL WENO schemes.

10 Convergence of semi-lagrangian schemes Filbet (SINUM 2001): PFC method for Vlasov-Poisson N. Besse (SINUM 2003): semi-lagrangian method with linear interpolation for Vlasov-Poisson. Campos Pinto - Mehrenberger (Numer. Math. 2008): adaptative SL method for Vlasov-Poisson N. Besse - Mehrenberger (Math of Comp 2008): split SL method for Vlasov-Poisson for symmetric high order interpolation Lagrange and spline interpolation. N. Besse (SINUM 2008): SL method with Hermite interpolation and propagation of gradients. Respaud - ES (Numer math, in revision): Forward SL for Vlasov-Poisson with linear interpolation.

11 Problem with non conservative Vlasov solver When non conservative splitting is used for the numerical solver, the solver is not exactly conservative. Does generally not matter when solution is smooth and well resolved by the grid. The solver is still second order and yields good results. However: Fine structures develop in non linear simulations and are at some point locally not well resolved by the phase space grid. In this case a non conservative solvers can exhibit a large numerical gain or loss of particles which is totally unphysical. Lack of robustness.

12 Vortex in Kelvin-Helmholtz instability diagt1kh2.plot u 1:3 diagt16kh2.plot u 1:3 diagt17kh2.plot u 1: diagt1kh2.plot u 1:4 diagt16kh2.plot u 1:4 diagt17kh2.plot u 1:

13 Computation of the origin of the characteristics Transport equation f t + a f = 0, Characteristics dx dt = a Computation of the origin of the characteristics : Explicit solution if a does not depend on x Else, numerical algorithm needed.

14 Splitting for exact computation of characteristics In many cases splitting can enable to solve a constant coefficient advection at each split step. E.g. separable Hamiltonian H(q, p) = U(q) + V (p). Vlasov equation in canonical coordinates reads f t + ph q f q H p f = 0. Split equations then become f t + pv q f = 0, f t qu p f = 0, where U does not depend on p and V does not depend on q characteristics can be solved explicitly. Vlasov-Poisson falls into this category with q = x, p = v, H(x, v) = 1 2 mv2 + qφ(x, t).

15 First order computation of characteristics Consider general case. Characteristics defined by dx dt = a(x, t). Backward solution: X n is known and a n known on the grid. Standard procedure to derive first order numerical method for EDO. Integrate on one time step and use quadrature formula for integral (left or right rectangle). X n+1 X n = t a n (X n ) or X n+1 X n = t a n+1 (X n+1 ). No explicit solution: Fixed point procedure needed in first case (e.g. Newton). Predictor-corrector method on a needed in second case.

16 Second order method for Vlasov-Poisson (1/2) Technique can be used for solving separable Hamiltonian Vlasov equations without splitting. We shall consider Vlasov-Poisson to illustrate this case. At time t n : f n and E n are known at grid points. f n+1 and E n+1 need to be computed. Need to solve characteristics backward in time from t n+1 to t n dv dt = E(X (t), t), dx dt = V. Main problem E n+1 needed and not known.

17 Second order method for Vlasov-Poisson (2/2) A second order in time algorithm predictor-corrector algorithm is defined as follows: 1 Predict Ē n+1 using continuity equation. 2 For all grid points x i = X n+1, v j = V n+1 compute V n+1/2 = V n+1 t 2 Ē n+1 (X n+1 ), X n = X n+1 tv n+1/2, V n = V n+1/2 t 2 E n (X n ). Interpolate f n at point (X n, V n ). 3 Yields first approximation of f n+1 (x i, v j ) = f n (X n, V n ) that can be used to correct Ē n+1. Iterate until Ē n+1 does not vary anymore. At most a couple iterations required.

18 A two step second order method Solve characteristics defined by dx dt = a(x, t). Centered quadrature on two time steps: X n+1 X n 1 = 2 t a n (X n ), X n+1 +X n 1 = 2X n +O( t 2 ). Use fixed point procedure to compute X n 1 such that X n+1 X n 1 = t a n ( Xn+1 + X n 1 ). 2 Problem: compute f n+1 from f n 1. Even and odd order time approximations become decoupled after some time. Artificial coupling needs to be introduced.

19 A one step predictor-corrector second order method Solve characteristics defined by dx dt = a(x, t). Centered quadrature on one time step: X n+1 X n = t a n+ 1 2 (X n+ 1 2 ), X n+1 +X n = 2X n O( t 2 ). Now a n+ 1 2 is unknown. Predictor-corrector procedure needed. Use fixed point procedure to compute X n such that X n+1 X n = t ā n+ 1 X n+1 + X n 2 ( ). 2 Both predictor-corrector and fixed point iterations needed.

20 The forward semi-lagrangian method f conserved along characteristics Characteristics advanced with same time schemes as in PIC method. Leap-Frog Vlasov-Poisson Runge-Kutta or Cauchy-Kovalevsky for guiding-center or gyrokinetic Values of f deposited on grid of phase space using convolution kernel. Identical to PIC deposition scheme but in whole phase space instead of configuration space only. Similar to PIC method with reconstruction introduced by Denavit (JCP 1972).

21 Discrete distribution function Function projected on partition of unity basis for conservativity. Good choice is cubic B-splines. f is reprojected on mesh at each time step. Between t n and t n+1 f h (x, v, t) = i,j w i,j B(x X (t; x i, v j, t n ))B(v X (t; x i, v j, t n )). Weight w i,j associated to the particle starting from grid point (x i, v j ) at t n is coefficient of spline satisfying interpolation conditions f h (x k, v l, t n ) = i,j w i,jb(x k x i )B(v l v j ). Projection on phase space mesh is obtained with formula f n+1 (x k, v l ) = i,j w i,j B(x k X (t n+1, x i, v j, t n ))B(v l V (t n+1, x i, v j, t n

22 Time advance for Vlasov-Poisson As opposite to BSL, trajectories are advanced forward in time. Advection field is known at initial time. Standard ODE algorithms can be applied. For Vlasov-Poisson, we have z(t n ) = (x n, v n ), and E(t n, z n ) = E(t n, x n ). Separable Hamiltonian. Natural scheme is Verlet algorithm, which is second order accurate in time Step1 : v n+ 1 2 v n = t 2 E(tn, x n ), Step2 : x n+1 x n = t v n+1/2, Step3 : v n+1 v n+ 1 2 = t 2 E(tn+1, x n+1 ).

23 Time advance for guiding-center Standard ODE solvers can be used in the general case, e.g. Runge-Kutta methods Second-order Runge Kutta method Step1 : X n+1 X n = te (t n, X n ) Step2 : Compute E (t n+1, X n+1 ) Step3 : X n+1 X n = t 2 [ ] E (t n, X n ) + E (t n+1, X n+1 ) Problem: Electric field needs to be computed at each stage. Computation time blows up when order (i.e. number of stages) are increased

24 Landau damping The Physics context 1 f 0 (x, v) = ( cos(kx)) e v2 2, L = 4π. 2π -6-8 Runs/thek.dat u 1: *x

25 Bump on tail (BSL (top) vs. FSL (bottom)) Electric energy time=0 time=20 time=30 Electric energy time=40 time=70 time= time time Electric energy time=0 time=20 time=30 Electric energy time=40 time=70 time= Simulation gyrocinétique 0 des plasmas de fusion magnétique

26 Bump on tail: total energy (BSL (left) vs. FSL (right))

27 Energy conservation for Kelvin-Helmoltz instability thdiago2.dat u 1:3 thdiago4.dat u 1:3../CG_BSL/thdiag.dat u 1:3 thdiag.dat u 1:

28 FSL vs. BSL The Physics context very promising. Accurate description of whole phase-space in particular tail of distribution function and small perturbations. A little more diffusive than BSL. Better with smaller time steps. Some advantages: classical explicit EDO solver can be used, in particular high order if needed. No need for predictor-corrector or fixed point algorithm. Can benefit from charge conserving PIC algorithms (Villasenor-Buneman).

29 Conservative semi-lagrangian method Start from conservative form of Vlasov equation f t + (f a) = 0. f dx dv conserved along caracteristics V Three steps: High order polynomial reconstruction. Resolution Projection Splitting conservative 1D equations. Filtering for positivity and suppressing oscillations.

30 Link between classical and conservative semi-lagrangian methods For constant coefficient advections we can show that C-Lag(2d) SL-Lag(2d+1) PSM SPL Consequences: 1 Classical semi-lagrangian method is conservative for split schemes reducing to constant coefficients advection for each split step. 2 PFC (Filbet-ES-Bertrand) corresponds to classical semi-lagrangian method with cubic Lagrange interpolation. 3 PSM corresponds to classical semi-lagrangian method with cubic spline interpolation. Note that Collella and Woodward Finite Volume scheme is also algebraically equivalent for constant coefficient advections.

31 Motivation for curvilinear coordinates Due to confinement by large magnetic field particle travel a lot faster along magnetic field lines than across. Look at typical turbulence simulation shows that large scale structures form along field line and small scale structures across. Significant anisotropy of flow For optimal resolution anisotropic mesh would be needed. Simplest idea used in most gyrokinetic codes: use curvilinear coordinates locally aligned with magnetic field lines.

32 L1 and L norms of relative error for oblic advection (travel 10 times the domain) function of the angle between advection direction and mesh lines direction:

33 4D drift-kinetic model From left to right: BSL, PSM and PSM with entropic flux limiter. 4D simulation of 128x256x128x64 cells, time =2000.

34 Semi-Lagrangian method has proved to be a good choice for full-f gyrokinetic simulations. 5D gyrokinetic code efficiently running on several thousands of processors. What option to best handle anisotropy and long time accuracy at minimal cost? Field aligned curvilinear coordinates first step. Best choice? Unstructured mesh. Not easy... NURBS for description of field lines and geometry of Tokamak.

New formulations of the semi-lagrangian method for Vlasov-type equations

New formulations of the semi-lagrangian method for Vlasov-type equations New formulations of the semi-lagrangian method for Vlasov-type equations Eric Sonnendrücker IRMA Université Louis Pasteur, Strasbourg projet CALVI INRIA Nancy Grand Est 17 September 2008 In collaboration

More information

Conservative Semi-Lagrangian solvers on mapped meshes

Conservative Semi-Lagrangian solvers on mapped meshes Conservative Semi-Lagrangian solvers on mapped meshes M. Mehrenberger, M. Bergot, V. Grandgirard, G. Latu, H. Sellama, E. Sonnendrücker Université de Strasbourg, INRIA Grand Est, Projet CALVI, ANR GYPSI

More information

Advective and conservative semi-lagrangian schemes on uniform and non-uniform grids

Advective and conservative semi-lagrangian schemes on uniform and non-uniform grids Advective and conservative semi-lagrangian schemes on uniform and non-uniform grids M. Mehrenberger Université de Strasbourg and Max-Planck Institut für Plasmaphysik 5 September 2013 M. Mehrenberger (UDS

More information

Semi-Lagrangian kinetic and gyrokinetic simulations

Semi-Lagrangian kinetic and gyrokinetic simulations Semi-Lagrangian kinetic and gyrokinetic simulations M. Mehrenberger IRMA, University of Strasbourg and TONUS project (INRIA) Marseille, Equations cinétiques, 11.11.2014 Collaborators : B. Afeyan, A. Back,

More information

CONSERVATIVE AND NON-CONSERVATIVE METHODS BASED ON HERMITE WEIGHTED ESSENTIALLY-NON-OSCILLATORY RECONSTRUCTION FOR VLASOV EQUATIONS

CONSERVATIVE AND NON-CONSERVATIVE METHODS BASED ON HERMITE WEIGHTED ESSENTIALLY-NON-OSCILLATORY RECONSTRUCTION FOR VLASOV EQUATIONS CONSERVATIVE AND NON-CONSERVATIVE METHODS BASED ON HERMITE WEIGHTED ESSENTIALLY-NON-OSCILLATORY RECONSTRUCTION FOR VLASOV EQUATIONS CHANG YANG AND FRANCIS FILBET Abstract. We develop weighted essentially

More information

Application of High Dimensional B-Spline Interpolation in Solving the Gyro-Kinetic Vlasov Equation Based on Semi-Lagrangian Method

Application of High Dimensional B-Spline Interpolation in Solving the Gyro-Kinetic Vlasov Equation Based on Semi-Lagrangian Method Commun Comput Phys doi: 1428/cicpOA-216-92 Vol 22, No 3, pp 789-82 September 217 Application of High Dimensional B-Spline Interpolation in Solving the Gyro-Kinetic Vlasov Equation Based on Semi-Lagrangian

More information

CONSERVATIVE AND NON-CONSERVATIVE METHODS BASED ON HERMITE WEIGHTED ESSENTIALLY-NON-OSCILLATORY RECONSTRUCTION FOR VLASOV EQUATIONS

CONSERVATIVE AND NON-CONSERVATIVE METHODS BASED ON HERMITE WEIGHTED ESSENTIALLY-NON-OSCILLATORY RECONSTRUCTION FOR VLASOV EQUATIONS CONSERVATIVE AND NON-CONSERVATIVE METHODS BASED ON HERMITE WEIGHTED ESSENTIALLY-NON-OSCILLATORY RECONSTRUCTION FOR VLASOV EQUATIONS CHANG YANG AND FRANCIS FILBET Abstract. We introduce a WENO reconstruction

More information

Conservative high order semi-lagrangian finite difference WENO methods for advection in incompressible flow. Abstract

Conservative high order semi-lagrangian finite difference WENO methods for advection in incompressible flow. Abstract Conservative high order semi-lagrangian finite difference WENO methods for advection in incompressible flow Jing-Mei Qiu 1 and Chi-Wang Shu Abstract In this paper, we propose a semi-lagrangian finite difference

More information

SPH: Towards the simulation of wave-body interactions in extreme seas

SPH: Towards the simulation of wave-body interactions in extreme seas SPH: Towards the simulation of wave-body interactions in extreme seas Guillaume Oger, Mathieu Doring, Bertrand Alessandrini, and Pierre Ferrant Fluid Mechanics Laboratory (CNRS UMR6598) Ecole Centrale

More information

Lagrangian methods and Smoothed Particle Hydrodynamics (SPH) Computation in Astrophysics Seminar (Spring 2006) L. J. Dursi

Lagrangian methods and Smoothed Particle Hydrodynamics (SPH) Computation in Astrophysics Seminar (Spring 2006) L. J. Dursi Lagrangian methods and Smoothed Particle Hydrodynamics (SPH) Eulerian Grid Methods The methods covered so far in this course use an Eulerian grid: Prescribed coordinates In `lab frame' Fluid elements flow

More information

CS205b/CME306. Lecture 9

CS205b/CME306. Lecture 9 CS205b/CME306 Lecture 9 1 Convection Supplementary Reading: Osher and Fedkiw, Sections 3.3 and 3.5; Leveque, Sections 6.7, 8.3, 10.2, 10.4. For a reference on Newton polynomial interpolation via divided

More information

Simulation in Computer Graphics. Particles. Matthias Teschner. Computer Science Department University of Freiburg

Simulation in Computer Graphics. Particles. Matthias Teschner. Computer Science Department University of Freiburg Simulation in Computer Graphics Particles Matthias Teschner Computer Science Department University of Freiburg Outline introduction particle motion finite differences system of first order ODEs second

More information

The WENO Method in the Context of Earlier Methods To approximate, in a physically correct way, [3] the solution to a conservation law of the form u t

The WENO Method in the Context of Earlier Methods To approximate, in a physically correct way, [3] the solution to a conservation law of the form u t An implicit WENO scheme for steady-state computation of scalar hyperbolic equations Sigal Gottlieb Mathematics Department University of Massachusetts at Dartmouth 85 Old Westport Road North Dartmouth,

More information

Development of a Maxwell Equation Solver for Application to Two Fluid Plasma Models. C. Aberle, A. Hakim, and U. Shumlak

Development of a Maxwell Equation Solver for Application to Two Fluid Plasma Models. C. Aberle, A. Hakim, and U. Shumlak Development of a Maxwell Equation Solver for Application to Two Fluid Plasma Models C. Aberle, A. Hakim, and U. Shumlak Aerospace and Astronautics University of Washington, Seattle American Physical Society

More information

Overview of Traditional Surface Tracking Methods

Overview of Traditional Surface Tracking Methods Liquid Simulation With Mesh-Based Surface Tracking Overview of Traditional Surface Tracking Methods Matthias Müller Introduction Research lead of NVIDIA PhysX team PhysX GPU acc. Game physics engine www.nvidia.com\physx

More information

A Block-Based Parallel Adaptive Scheme for Solving the 4D Vlasov Equation

A Block-Based Parallel Adaptive Scheme for Solving the 4D Vlasov Equation A Block-Based Parallel Adaptive Scheme for Solving the 4D Vlasov Equation Olivier Hoenen and Eric Violard Laboratoire LSIIT - ICPS, UMR CNRS 7005 Université Louis Pasteur, Strasbourg {hoenen,violard}@icps.u-strasbg.fr

More information

A Semi-Lagrangian Discontinuous Galerkin (SLDG) Conservative Transport Scheme on the Cubed-Sphere

A Semi-Lagrangian Discontinuous Galerkin (SLDG) Conservative Transport Scheme on the Cubed-Sphere A Semi-Lagrangian Discontinuous Galerkin (SLDG) Conservative Transport Scheme on the Cubed-Sphere Ram Nair Computational and Information Systems Laboratory (CISL) National Center for Atmospheric Research

More information

This is an author-deposited version published in: Eprints ID: 4362

This is an author-deposited version published in:   Eprints ID: 4362 This is an author-deposited version published in: http://oatao.univ-toulouse.fr/ Eprints ID: 4362 To cite this document: CHIKHAOUI Oussama, GRESSIER Jérémie, GRONDIN Gilles. Assessment of the Spectral

More information

High-Order Finite Difference Schemes for computational MHD

High-Order Finite Difference Schemes for computational MHD High-Order Finite Difference Schemes for computational MHD A. Mignone 1, P. Tzeferacos 1 and G. Bodo 2 [1] Dipartimento di Fisica Generale, Turin University, ITALY [2] INAF Astronomic Observatory of Turin,,

More information

High-order, conservative, finite difference schemes for computational MHD

High-order, conservative, finite difference schemes for computational MHD High-order, conservative, finite difference schemes for computational MHD A. Mignone 1, P. Tzeferacos 1 and G. Bodo 2 [1] Dipartimento di Fisica Generale, Turin University, ITALY [2] INAF Astronomic Observatory

More information

Adaptive Methods for the Vlasov Equation

Adaptive Methods for the Vlasov Equation Adaptive Methods for the Vlasov Equation Eric Sonnendrücker IRMA, Université de Strasbourg and CNRS projet CALVI INRIA Lorraine SMAI 2009, La Colle sur Loup, 25-29 May 2009 in collaboration with N. Besse,

More information

Solving the guiding-center model on a regular hexagonal mesh

Solving the guiding-center model on a regular hexagonal mesh Solving the guiding-center model on a regular hexagonal mesh Michel Mehrenberger, Laura S. Mendoza, Charles Prouveur, Eric Sonnendrücker To cite this version: Michel Mehrenberger, Laura S. Mendoza, Charles

More information

Imaging of flow in porous media - from optimal transport to prediction

Imaging of flow in porous media - from optimal transport to prediction Imaging of flow in porous media - from optimal transport to prediction Eldad Haber Dept of EOS and Mathematics, UBC October 15, 2013 With Rowan Lars Jenn Cocket Ruthotto Fohring Outline Prediction is very

More information

SPH: Why and what for?

SPH: Why and what for? SPH: Why and what for? 4 th SPHERIC training day David Le Touzé, Fluid Mechanics Laboratory, Ecole Centrale de Nantes / CNRS SPH What for and why? How it works? Why not for everything? Duality of SPH SPH

More information

An explicit and conservative remapping strategy for semi-lagrangian advection

An explicit and conservative remapping strategy for semi-lagrangian advection An explicit and conservative remapping strategy for semi-lagrangian advection Sebastian Reich Universität Potsdam, Potsdam, Germany January 17, 2007 Abstract A conservative semi-lagrangian advection scheme

More information

CS-184: Computer Graphics Lecture #21: Fluid Simulation II

CS-184: Computer Graphics Lecture #21: Fluid Simulation II CS-184: Computer Graphics Lecture #21: Fluid Simulation II Rahul Narain University of California, Berkeley Nov. 18 19, 2013 Grid-based fluid simulation Recap: Eulerian viewpoint Grid is fixed, fluid moves

More information

The Semi-Lagrangian Method for the Numerical Resolution of Vlasov Equations

The Semi-Lagrangian Method for the Numerical Resolution of Vlasov Equations The Semi-Lagrangian Method for the Numerical Resolution of Vlasov Equations Eric Sonnendrücker Jean Roche Pierre Bertrand Alain Ghizzo To cite this version: Eric Sonnendrücker Jean Roche Pierre Bertrand

More information

Computational Astrophysics 5 Higher-order and AMR schemes

Computational Astrophysics 5 Higher-order and AMR schemes Computational Astrophysics 5 Higher-order and AMR schemes Oscar Agertz Outline - The Godunov Method - Second-order scheme with MUSCL - Slope limiters and TVD schemes - Characteristics tracing and 2D slopes.

More information

A mass-conservative version of the semi- Lagrangian semi-implicit HIRLAM using Lagrangian vertical coordinates

A mass-conservative version of the semi- Lagrangian semi-implicit HIRLAM using Lagrangian vertical coordinates A mass-conservative version of the semi- Lagrangian semi-implicit HIRLAM using Lagrangian vertical coordinates Peter Hjort Lauritzen Atmospheric Modeling & Predictability Section National Center for Atmospheric

More information

A methodology for the rigorous verification of plasma simulation codes

A methodology for the rigorous verification of plasma simulation codes A methodology for the rigorous verification of plasma simulation codes Fabio Riva P. Ricci, C. Beadle, F.D. Halpern, S. Jolliet, J. Loizu, J. Morales, A. Mosetto, P. Paruta, C. Wersal École Polytechnique

More information

Numerical Methods for (Time-Dependent) HJ PDEs

Numerical Methods for (Time-Dependent) HJ PDEs Numerical Methods for (Time-Dependent) HJ PDEs Ian Mitchell Department of Computer Science The University of British Columbia research supported by National Science and Engineering Research Council of

More information

Homogenization and numerical Upscaling. Unsaturated flow and two-phase flow

Homogenization and numerical Upscaling. Unsaturated flow and two-phase flow Homogenization and numerical Upscaling Unsaturated flow and two-phase flow Insa Neuweiler Institute of Hydromechanics, University of Stuttgart Outline Block 1: Introduction and Repetition Homogenization

More information

Numerical Methods for Hyperbolic and Kinetic Equations

Numerical Methods for Hyperbolic and Kinetic Equations Numerical Methods for Hyperbolic and Kinetic Equations Organizer: G. Puppo Phenomena characterized by conservation (or balance laws) of physical quantities are modelled by hyperbolic and kinetic equations.

More information

Chapter 6. Semi-Lagrangian Methods

Chapter 6. Semi-Lagrangian Methods Chapter 6. Semi-Lagrangian Methods References: Durran Chapter 6. Review article by Staniford and Cote (1991) MWR, 119, 2206-2223. 6.1. Introduction Semi-Lagrangian (S-L for short) methods, also called

More information

An explicit and conservative remapping strategy for semi-lagrangian advection

An explicit and conservative remapping strategy for semi-lagrangian advection ATMOSPHERIC SCIENCE LETTERS Atmos. Sci. Let. 8: 58 63 (2007) Published online 22 May 2007 in Wiley InterScience (www.interscience.wiley.com).151 An explicit and conservative remapping strategy for semi-lagrangian

More information

Considerations about level-set methods: Accuracy, interpolation and reinitialization

Considerations about level-set methods: Accuracy, interpolation and reinitialization Considerations about level-set methods: Accuracy, interpolation and reinitialization Gustavo C. Buscaglia Coll: E. Dari, R. Ausas, L. Ruspini Instituto de Ciências Matemáticas e de Computação Universidade

More information

1 Past Research and Achievements

1 Past Research and Achievements Parallel Mesh Generation and Adaptation using MAdLib T. K. Sheel MEMA, Universite Catholique de Louvain Batiment Euler, Louvain-La-Neuve, BELGIUM Email: tarun.sheel@uclouvain.be 1 Past Research and Achievements

More information

Partial Differential Equations

Partial Differential Equations Simulation in Computer Graphics Partial Differential Equations Matthias Teschner Computer Science Department University of Freiburg Motivation various dynamic effects and physical processes are described

More information

Auto Injector Syringe. A Fluent Dynamic Mesh 1DOF Tutorial

Auto Injector Syringe. A Fluent Dynamic Mesh 1DOF Tutorial Auto Injector Syringe A Fluent Dynamic Mesh 1DOF Tutorial 1 2015 ANSYS, Inc. June 26, 2015 Prerequisites This tutorial is written with the assumption that You have attended the Introduction to ANSYS Fluent

More information

Math 225 Scientific Computing II Outline of Lectures

Math 225 Scientific Computing II Outline of Lectures Math 225 Scientific Computing II Outline of Lectures Spring Semester 2003 I. Interpolating polynomials Lagrange formulation of interpolating polynomial Uniqueness of interpolating polynomial of degree

More information

Michel Mehrenberger 1, Laura S. Mendoza 2, 3, Charles Prouveur 4 and Eric Sonnendrücker 2,3

Michel Mehrenberger 1, Laura S. Mendoza 2, 3, Charles Prouveur 4 and Eric Sonnendrücker 2,3 ESAIM: PROCEEDINGS AND SURVEYS, March 2016, Vol. 53, p. 149-176 M. Campos Pinto and F. Charles, Editors SOLVING THE GUIDING-CENTER MODEL ON A REGULAR HEXAGONAL MESH Michel Mehrenberger 1, Laura S. Mendoza

More information

A brief description of the particle finite element method (PFEM2). Extensions to free surface

A brief description of the particle finite element method (PFEM2). Extensions to free surface A brief description of the particle finite element method (PFEM2). Extensions to free surface flows. Juan M. Gimenez, L.M. González, CIMEC Universidad Nacional del Litoral (UNL) Santa Fe, Argentina Universidad

More information

Weno Scheme for Transport Equation on Unstructured Grids with a DDFV Approach

Weno Scheme for Transport Equation on Unstructured Grids with a DDFV Approach Weno Scheme for Transport Equation on Unstructured Grids with a DDFV Approach Florence Hubert and Rémi Tesson Abstract In this paper we develop a DDFV approach for WENO scheme on unstructred grids for

More information

The 3D DSC in Fluid Simulation

The 3D DSC in Fluid Simulation The 3D DSC in Fluid Simulation Marek K. Misztal Informatics and Mathematical Modelling, Technical University of Denmark mkm@imm.dtu.dk DSC 2011 Workshop Kgs. Lyngby, 26th August 2011 Governing Equations

More information

99 International Journal of Engineering, Science and Mathematics

99 International Journal of Engineering, Science and Mathematics Journal Homepage: Applications of cubic splines in the numerical solution of polynomials Najmuddin Ahmad 1 and Khan Farah Deeba 2 Department of Mathematics Integral University Lucknow Abstract: In this

More information

arxiv: v4 [math.na] 22 Sep 2017

arxiv: v4 [math.na] 22 Sep 2017 A high order conservative semi-lagrangian discontinuous Galerkin method for two-dimensional transport simulations Xiaofeng Cai 1, Wei Guo, Jing-Mei Qiu 3 Dedicated to Prof. Chi-Wang Shu on his 60th birthday.

More information

Advanced Numeric for elm s : Models and Optimized Strategies (ANEMOS)

Advanced Numeric for elm s : Models and Optimized Strategies (ANEMOS) Advanced Numeric for elm s : Models and Optimized Strategies (ANEMOS) ANR-11-MONU-002 Oct. 2011 to Sep. 2015 B. Nkonga et al. ANEMOS : ANR-11-MONU-002 1 / 26 Overview 1 General framework 2 Goals and Tasks

More information

Numerical Methods. (Additional Notes from Talks by PFH)

Numerical Methods. (Additional Notes from Talks by PFH) Numerical Methods (Additional Notes from Talks by PFH) SPH Challenge: POPULAR METHODS FOR HYDRODYNAMICS HAVE PROBLEMS Lucy 77, Gingold & Monaghan 77 Reviews by: Springel 11, Price 12 Smoothed-Particle

More information

BIRS Workshop 11w Advancing numerical methods for viscosity solutions and applications

BIRS Workshop 11w Advancing numerical methods for viscosity solutions and applications BIRS Workshop 11w5086 - Advancing numerical methods for viscosity solutions and applications Abstracts of talks February 11, 2011 M. Akian, Max Plus algebra in the numerical solution of Hamilton Jacobi

More information

EXPOSING PARTICLE PARALLELISM IN THE XGC PIC CODE BY EXPLOITING GPU MEMORY HIERARCHY. Stephen Abbott, March

EXPOSING PARTICLE PARALLELISM IN THE XGC PIC CODE BY EXPLOITING GPU MEMORY HIERARCHY. Stephen Abbott, March EXPOSING PARTICLE PARALLELISM IN THE XGC PIC CODE BY EXPLOITING GPU MEMORY HIERARCHY Stephen Abbott, March 26 2018 ACKNOWLEDGEMENTS Collaborators: Oak Ridge Nation Laboratory- Ed D Azevedo NVIDIA - Peng

More information

Mid-Year Report. Discontinuous Galerkin Euler Equation Solver. Friday, December 14, Andrey Andreyev. Advisor: Dr.

Mid-Year Report. Discontinuous Galerkin Euler Equation Solver. Friday, December 14, Andrey Andreyev. Advisor: Dr. Mid-Year Report Discontinuous Galerkin Euler Equation Solver Friday, December 14, 2012 Andrey Andreyev Advisor: Dr. James Baeder Abstract: The focus of this effort is to produce a two dimensional inviscid,

More information

Parameterization of triangular meshes

Parameterization of triangular meshes Parameterization of triangular meshes Michael S. Floater November 10, 2009 Triangular meshes are often used to represent surfaces, at least initially, one reason being that meshes are relatively easy to

More information

High Order Weighted Essentially Non-Oscillatory Schemes for Convection. Dominated Problems. Chi-Wang Shu 1

High Order Weighted Essentially Non-Oscillatory Schemes for Convection. Dominated Problems. Chi-Wang Shu 1 High Order Weighted Essentially Non-Oscillatory Schemes for Convection Dominated Problems Chi-Wang Shu Division of Applied Mathematics, Brown University, Providence, Rhode Island 09 ABSTRACT High order

More information

Multigrid Pattern. I. Problem. II. Driving Forces. III. Solution

Multigrid Pattern. I. Problem. II. Driving Forces. III. Solution Multigrid Pattern I. Problem Problem domain is decomposed into a set of geometric grids, where each element participates in a local computation followed by data exchanges with adjacent neighbors. The grids

More information

CS 450 Numerical Analysis. Chapter 7: Interpolation

CS 450 Numerical Analysis. Chapter 7: Interpolation Lecture slides based on the textbook Scientific Computing: An Introductory Survey by Michael T. Heath, copyright c 2018 by the Society for Industrial and Applied Mathematics. http://www.siam.org/books/cl80

More information

Fluent User Services Center

Fluent User Services Center Solver Settings 5-1 Using the Solver Setting Solver Parameters Convergence Definition Monitoring Stability Accelerating Convergence Accuracy Grid Independence Adaption Appendix: Background Finite Volume

More information

Metafor FE Software. 2. Operator split. 4. Rezoning methods 5. Contact with friction

Metafor FE Software. 2. Operator split. 4. Rezoning methods 5. Contact with friction ALE simulations ua sus using Metafor eao 1. Introduction 2. Operator split 3. Convection schemes 4. Rezoning methods 5. Contact with friction 1 Introduction EULERIAN FORMALISM Undistorted mesh Ideal for

More information

Mass-Spring Systems. Last Time?

Mass-Spring Systems. Last Time? Mass-Spring Systems Last Time? Implicit Surfaces & Marching Cubes/Tetras Collision Detection & Conservative Bounding Regions Spatial Acceleration Data Structures Octree, k-d tree, BSF tree 1 Today Particle

More information

Multi-Mesh CFD. Chris Roy Chip Jackson (1 st year PhD student) Aerospace and Ocean Engineering Department Virginia Tech

Multi-Mesh CFD. Chris Roy Chip Jackson (1 st year PhD student) Aerospace and Ocean Engineering Department Virginia Tech Multi-Mesh CFD Chris Roy Chip Jackson (1 st year PhD student) Aerospace and Ocean Engineering Department Virginia Tech cjroy@vt.edu May 21, 2014 CCAS Program Review, Columbus, OH 1 Motivation Automated

More information

Efficiency of adaptive mesh algorithms

Efficiency of adaptive mesh algorithms Efficiency of adaptive mesh algorithms 23.11.2012 Jörn Behrens KlimaCampus, Universität Hamburg http://www.katrina.noaa.gov/satellite/images/katrina-08-28-2005-1545z.jpg Model for adaptive efficiency 10

More information

Asynchronous OpenCL/MPI numerical simulations of conservation laws

Asynchronous OpenCL/MPI numerical simulations of conservation laws Asynchronous OpenCL/MPI numerical simulations of conservation laws Philippe HELLUY 1,3, Thomas STRUB 2. 1 IRMA, Université de Strasbourg, 2 AxesSim, 3 Inria Tonus, France IWOCL 2015, Stanford Conservation

More information

A new multidimensional-type reconstruction and limiting procedure for unstructured (cell-centered) FVs solving hyperbolic conservation laws

A new multidimensional-type reconstruction and limiting procedure for unstructured (cell-centered) FVs solving hyperbolic conservation laws HYP 2012, Padova A new multidimensional-type reconstruction and limiting procedure for unstructured (cell-centered) FVs solving hyperbolic conservation laws Argiris I. Delis & Ioannis K. Nikolos (TUC)

More information

FAST ALGORITHMS FOR CALCULATIONS OF VISCOUS INCOMPRESSIBLE FLOWS USING THE ARTIFICIAL COMPRESSIBILITY METHOD

FAST ALGORITHMS FOR CALCULATIONS OF VISCOUS INCOMPRESSIBLE FLOWS USING THE ARTIFICIAL COMPRESSIBILITY METHOD TASK QUARTERLY 12 No 3, 273 287 FAST ALGORITHMS FOR CALCULATIONS OF VISCOUS INCOMPRESSIBLE FLOWS USING THE ARTIFICIAL COMPRESSIBILITY METHOD ZBIGNIEW KOSMA Institute of Applied Mechanics, Technical University

More information

The vertical stratification is modeled by 4 layers in which we work with averaged concentrations in vertical direction:

The vertical stratification is modeled by 4 layers in which we work with averaged concentrations in vertical direction: Numerical methods in smog prediction M. van Loon Center for Mathematics and Computer Science, dep. AW, P.O. Boz ^072 J(%%? GB Ams

More information

Computer Simulations

Computer Simulations Computer Simulations A practical approach to simulation Semra Gündüç gunduc@ankara.edu.tr Ankara University Faculty of Engineering, Department of Computer Engineering 2014-2015 Spring Term Ankara University

More information

ALE and AMR Mesh Refinement Techniques for Multi-material Hydrodynamics Problems

ALE and AMR Mesh Refinement Techniques for Multi-material Hydrodynamics Problems ALE and AMR Mesh Refinement Techniques for Multi-material Hydrodynamics Problems A. J. Barlow, AWE. ICFD Workshop on Mesh Refinement Techniques 7th December 2005 Acknowledgements Thanks to Chris Powell,

More information

BACK AND FORTH ERROR COMPENSATION AND CORRECTION METHODS FOR REMOVING ERRORS INDUCED BY UNEVEN GRADIENTS OF THE LEVEL SET FUNCTION

BACK AND FORTH ERROR COMPENSATION AND CORRECTION METHODS FOR REMOVING ERRORS INDUCED BY UNEVEN GRADIENTS OF THE LEVEL SET FUNCTION BACK AND FORTH ERROR COMPENSATION AND CORRECTION METHODS FOR REMOVING ERRORS INDUCED BY UNEVEN GRADIENTS OF THE LEVEL SET FUNCTION TODD F. DUPONT AND YINGJIE LIU Abstract. We propose a method that significantly

More information

Adarsh Krishnamurthy (cs184-bb) Bela Stepanova (cs184-bs)

Adarsh Krishnamurthy (cs184-bb) Bela Stepanova (cs184-bs) OBJECTIVE FLUID SIMULATIONS Adarsh Krishnamurthy (cs184-bb) Bela Stepanova (cs184-bs) The basic objective of the project is the implementation of the paper Stable Fluids (Jos Stam, SIGGRAPH 99). The final

More information

AMS527: Numerical Analysis II

AMS527: Numerical Analysis II AMS527: Numerical Analysis II A Brief Overview of Finite Element Methods Xiangmin Jiao SUNY Stony Brook Xiangmin Jiao SUNY Stony Brook AMS527: Numerical Analysis II 1 / 25 Overview Basic concepts Mathematical

More information

Level set methods Formulation of Interface Propagation Boundary Value PDE Initial Value PDE Motion in an externally generated velocity field

Level set methods Formulation of Interface Propagation Boundary Value PDE Initial Value PDE Motion in an externally generated velocity field Level Set Methods Overview Level set methods Formulation of Interface Propagation Boundary Value PDE Initial Value PDE Motion in an externally generated velocity field Convection Upwind ddifferencingi

More information

COMPUTER AIDED ENGINEERING DESIGN (BFF2612)

COMPUTER AIDED ENGINEERING DESIGN (BFF2612) COMPUTER AIDED ENGINEERING DESIGN (BFF2612) BASIC MATHEMATICAL CONCEPTS IN CAED by Dr. Mohd Nizar Mhd Razali Faculty of Manufacturing Engineering mnizar@ump.edu.my COORDINATE SYSTEM y+ y+ z+ z+ x+ RIGHT

More information

Physics Tutorial 2: Numerical Integration Methods

Physics Tutorial 2: Numerical Integration Methods Physics Tutorial 2: Numerical Integration Methods Summary The concept of numerically solving differential equations is explained, and applied to real time gaming simulation. Some objects are moved in a

More information

APPROXIMATING PDE s IN L 1

APPROXIMATING PDE s IN L 1 APPROXIMATING PDE s IN L 1 Veselin Dobrev Jean-Luc Guermond Bojan Popov Department of Mathematics Texas A&M University NONLINEAR APPROXIMATION TECHNIQUES USING L 1 Texas A&M May 16-18, 2008 Outline 1 Outline

More information

Characteristic Aspects of SPH Solutions

Characteristic Aspects of SPH Solutions Characteristic Aspects of SPH Solutions for Free Surface Problems: Source and Possible Treatment of High Frequency Numerical Oscillations of Local Loads. A. Colagrossi*, D. Le Touzé & G.Colicchio* *INSEAN

More information

Final Report. Discontinuous Galerkin Compressible Euler Equation Solver. May 14, Andrey Andreyev. Adviser: Dr. James Baeder

Final Report. Discontinuous Galerkin Compressible Euler Equation Solver. May 14, Andrey Andreyev. Adviser: Dr. James Baeder Final Report Discontinuous Galerkin Compressible Euler Equation Solver May 14, 2013 Andrey Andreyev Adviser: Dr. James Baeder Abstract: In this work a Discontinuous Galerkin Method is developed for compressible

More information

Water. Notes. Free surface. Boundary conditions. This week: extend our 3D flow solver to full 3D water We need to add two things:

Water. Notes. Free surface. Boundary conditions. This week: extend our 3D flow solver to full 3D water We need to add two things: Notes Added a 2D cross-section viewer for assignment 6 Not great, but an alternative if the full 3d viewer isn t working for you Warning about the formulas in Fedkiw, Stam, and Jensen - maybe not right

More information

A TSTT integrated FronTier code and its applications in computational fluid physics

A TSTT integrated FronTier code and its applications in computational fluid physics Institute of Physics Publishing Journal of Physics: Conference Series 16 (2005) 471 475 doi:10.1088/1742-6596/16/1/064 SciDAC 2005 A TSTT integrated FronTier code and its applications in computational

More information

J. Vira, M. Sofiev SILAM winter school, February 2013, FMI

J. Vira, M. Sofiev SILAM winter school, February 2013, FMI Numerical aspects of the advection-diffusion equation J. Vira, M. Sofiev SILAM winter school, February 2013, FMI Outline Intro Some common requirements for numerical transport schemes Lagrangian approach

More information

over The idea is to construct an algorithm to solve the IVP ODE (9.1)

over The idea is to construct an algorithm to solve the IVP ODE (9.1) Runge- Ku(a Methods Review of Heun s Method (Deriva:on from Integra:on) The idea is to construct an algorithm to solve the IVP ODE (9.1) over To obtain the solution point we can use the fundamental theorem

More information

On the thickness of discontinuities computed by THINC and RK schemes

On the thickness of discontinuities computed by THINC and RK schemes The 9th Computational Fluid Dynamics Symposium B7- On the thickness of discontinuities computed by THINC and RK schemes Taku Nonomura, ISAS, JAXA, Sagamihara, Kanagawa, Japan, E-mail:nonomura@flab.isas.jaxa.jp

More information

An Introduction to Flow Visualization (1) Christoph Garth

An Introduction to Flow Visualization (1) Christoph Garth An Introduction to Flow Visualization (1) Christoph Garth cgarth@ucdavis.edu Motivation What will I be talking about? Classical: Physical experiments to understand flow. 2 Motivation What will I be talking

More information

Interpolation and Splines

Interpolation and Splines Interpolation and Splines Anna Gryboś October 23, 27 1 Problem setting Many of physical phenomenona are described by the functions that we don t know exactly. Often we can calculate or measure the values

More information

Lecture 9. Curve fitting. Interpolation. Lecture in Numerical Methods from 28. April 2015 UVT. Lecture 9. Numerical. Interpolation his o

Lecture 9. Curve fitting. Interpolation. Lecture in Numerical Methods from 28. April 2015 UVT. Lecture 9. Numerical. Interpolation his o Curve fitting. Lecture in Methods from 28. April 2015 to ity Interpolation FIGURE A S Splines Piecewise relat UVT Agenda of today s lecture 1 Interpolation Idea 2 3 4 5 6 Splines Piecewise Interpolation

More information

Semi-Conservative Schemes for Conservation Laws

Semi-Conservative Schemes for Conservation Laws Semi-Conservative Schemes for Conservation Laws Rosa Maria Pidatella 1 Gabriella Puppo, 2 Giovanni Russo, 1 Pietro Santagati 1 1 Università degli Studi di Catania, Catania, Italy 2 Università dell Insubria,

More information

Stability Analysis of the Muscl Method on General Unstructured Grids for Applications to Compressible Fluid Flow

Stability Analysis of the Muscl Method on General Unstructured Grids for Applications to Compressible Fluid Flow Stability Analysis of the Muscl Method on General Unstructured Grids for Applications to Compressible Fluid Flow F. Haider 1, B. Courbet 1, J.P. Croisille 2 1 Département de Simulation Numérique des Ecoulements

More information

Integral Equation Methods for Vortex Dominated Flows, a High-order Conservative Eulerian Approach

Integral Equation Methods for Vortex Dominated Flows, a High-order Conservative Eulerian Approach Integral Equation Methods for Vortex Dominated Flows, a High-order Conservative Eulerian Approach J. Bevan, UIUC ICERM/HKUST Fast Integral Equation Methods January 5, 2016 Vorticity and Circulation Γ =

More information

Presented by Wayne Arter CCFE, Culham Science Centre, Abingdon, Oxon., UK

Presented by Wayne Arter CCFE, Culham Science Centre, Abingdon, Oxon., UK Software Engineering for Fusion Reactor Design Presented by Wayne Arter CCFE, Culham Science Centre, Abingdon, Oxon., UK Software Engineering Assembly (SEA) - April 2018 1 Outline Show how we have produced

More information

Chapter 6 Visualization Techniques for Vector Fields

Chapter 6 Visualization Techniques for Vector Fields Chapter 6 Visualization Techniques for Vector Fields 6.1 Introduction 6.2 Vector Glyphs 6.3 Particle Advection 6.4 Streamlines 6.5 Line Integral Convolution 6.6 Vector Topology 6.7 References 2006 Burkhard

More information

Particle-based Fluid Simulation

Particle-based Fluid Simulation Simulation in Computer Graphics Particle-based Fluid Simulation Matthias Teschner Computer Science Department University of Freiburg Application (with Pixar) 10 million fluid + 4 million rigid particles,

More information

The Finite Element Method for the Analysis of Non-Linear and Dynamic Systems. Prof. Dr. Eleni Chatzi, J.P. Escallo n Lecture December, 2013

The Finite Element Method for the Analysis of Non-Linear and Dynamic Systems. Prof. Dr. Eleni Chatzi, J.P. Escallo n Lecture December, 2013 The Finite Element Method for the Analysis of Non-Linear and Dynamic Systems Prof. Dr. Eleni Chatzi, J.P. Escallo n Lecture 11-17 December, 2013 Institute of Structural Engineering Method of Finite Elements

More information

An added mass partitioned algorithm for rigid bodies and incompressible flows

An added mass partitioned algorithm for rigid bodies and incompressible flows An added mass partitioned algorithm for rigid bodies and incompressible flows Jeff Banks Rensselaer Polytechnic Institute Overset Grid Symposium Mukilteo, WA October 19, 216 Collaborators Bill Henshaw,

More information

Is GPU the future of Scientific Computing?

Is GPU the future of Scientific Computing? Is GPU the future of Scientific Computing? Georges-Henri Cottet, Jean-Matthieu Etancelin, Franck Pérignon, Christophe Picard, Florian De Vuyst, Christophe Labourdette To cite this version: Georges-Henri

More information

CS 231. Fluid simulation

CS 231. Fluid simulation CS 231 Fluid simulation Why Simulate Fluids? Feature film special effects Computer games Medicine (e.g. blood flow in heart) Because it s fun Fluid Simulation Called Computational Fluid Dynamics (CFD)

More information

Challenges in adapting Particle-In-Cell codes to GPUs and many-core platforms

Challenges in adapting Particle-In-Cell codes to GPUs and many-core platforms Challenges in adapting Particle-In-Cell codes to GPUs and many-core platforms L. Villard, T.M. Tran, F. Hariri *, E. Lanti, N. Ohana, S. Brunner Swiss Plasma Center, EPFL, Lausanne A. Jocksch, C. Gheller

More information

1.7.1 Laplacian Smoothing

1.7.1 Laplacian Smoothing 1.7.1 Laplacian Smoothing 320491: Advanced Graphics - Chapter 1 434 Theory Minimize energy functional total curvature estimate by polynomial-fitting non-linear (very slow!) 320491: Advanced Graphics -

More information

Discontinuous Galerkin Sparse Grid method for Maxwell s equations

Discontinuous Galerkin Sparse Grid method for Maxwell s equations Discontinuous Galerkin Sparse Grid method for Maxwell s equations Student: Tianyang Wang Mentor: Dr. Lin Mu, Dr. David L.Green, Dr. Ed D Azevedo, Dr. Kwai Wong Motivation u We consider the Maxwell s equations,

More information

A gradient-augmented level set method with an optimally local, coherent advection scheme

A gradient-augmented level set method with an optimally local, coherent advection scheme A gradient-augmented level set method with an optimally local, coherent advection scheme The MIT Faculty has made this article openly available. Please share how this access benefits you. Your story matters.

More information

Recent developments for the multigrid scheme of the DLR TAU-Code

Recent developments for the multigrid scheme of the DLR TAU-Code www.dlr.de Chart 1 > 21st NIA CFD Seminar > Axel Schwöppe Recent development s for the multigrid scheme of the DLR TAU-Code > Apr 11, 2013 Recent developments for the multigrid scheme of the DLR TAU-Code

More information

Moving Interface Problems: Methods & Applications Tutorial Lecture II

Moving Interface Problems: Methods & Applications Tutorial Lecture II Moving Interface Problems: Methods & Applications Tutorial Lecture II Grétar Tryggvason Worcester Polytechnic Institute Moving Interface Problems and Applications in Fluid Dynamics Singapore National University,

More information

A dedicated Compression Scheme for Large Multidimensional Functions Visualization

A dedicated Compression Scheme for Large Multidimensional Functions Visualization A dedicated Compression Scheme for Large Multidimensional Functions Visualization M. Haefele IRMA, UMR CNRS 750 Université Louis Pasteur Strasbourg, F-6708, France haefele@math.u-strasbg.fr F. Zara LIRIS,

More information