High Order Semi-Lagrangian WENO scheme for Vlasov Equations

Size: px
Start display at page:

Download "High Order Semi-Lagrangian WENO scheme for Vlasov Equations"

Transcription

1 High Order WENO scheme for Equations Department of Mathematical and Computer Science Colorado School of Mines joint work w/ Andrew Christlieb Supported by AFOSR. Computational Mathematics Seminar, UC Boulder 1 / 39

2 Outline -Poisson system Typical numerical approach The proposed semi- (SL) WENO method High order accuracy for smooth structure and non-oscillatory resolution for sharp interface Mass conservation Allows for large time step results 2 / 39

3 VP system The collisionless plasma may be described by the well-known -Poisson (VP) system, f t + v xf + E(t, x) v f = 0, (1) E(t, x) = x φ(t, x), x φ(t, x) = ρ(t, x). (2) f (t, x, v): the probability of finding a particle with velocity v at position x at time t. ρ(t, x) = f (t, x, v)dv - 1: charge density 3 / 39

4 Numerical approach: vs. Eulerian : tracking a finite number of macro-particles. e.g., PIC (Particle In Cell) dx dt = v, dv dt = E (3) Eulerian: fixed numerical mesh e.g., finite difference WENO, semi-, finite volume, finite element, spectral method. 4 / 39

5 Numerical Challenge : suffers from the statistical noise (O(1/ N)). Eulerian: suffers the curse of dimensionality for a multi-d (up to 6) problem. Our approach: A very high order semi- approach with relatively coarse numerical mesh in both space and time. 5 / 39

6 The SL WENO method Key Component Strang splitting Conservative form of semi- (SL) scheme WENO reconstruction. 6 / 39

7 Strang splitting f t + v xf + E(t, x) v f = 0, Nonlinear eqation a sequence of linear s. 1-D in x and 1-D in v: f t + v f x = 0, (4) f t + E(t, x) f v = 0. (5) 7 / 39

8 Strang Splitting for solving the 1 Evolve (4) for t 2, 2 Compute E from the Poisson s, 3 Evolve (5) for t, 4 Evolve (4) for t 2. 8 / 39

9 Linear transport 1 Shifting of solution profile f t + v f x = 0, 2 Mass conservation (if the boundary condition is periodic) d f (x, t)dx dt = 0 9 / 39

10 SL method for linear transport f t + v f x = 0, Numerical scheme: evolution solution from t n to t n+1 1 reconstruction: determine accuracy quality of the scheme. 2 shifting: by v t Let ξ 0 = v t x, f n+1 i = f (x i, t n+1 ) = f (x i ξ 0 x, t n ) 10 / 39

11 Third order example When ξ 0 [0, 1 2 ] t n+1 t n x 0 x i 2 x i 1 x i x i+1 x i+2 x N ξ 0 [0, 1 2 ] 11 / 39

12 Third order example When ξ 0 [0, 1 2 ] When ξ 0 [ 1 2, 0] t n+1 t n x 0 x i 2 x i 1 x i x i+1 x i+2 x N ξ 0 [0, 1 2 ] ξ 0 [ 1 2, 0] 11 / 39

13 When ξ 0 [0, 1 2 ] f n+1 i = fi n + ( 1 6 f i 2 n + fi 1 n 1 2 f i n 1 3 f i+1)ξ n 0 + ( 1 2 f i 1 n fi n f i+1)ξ n ( 1 6 f i 2 n 1 2 f i 1 n f i n 1 6 f i+1)ξ n 0, 3 (6) 12 / 39

14 Matrix Vector From f n+1 i with matrix A L 3 = = = f n i + ξ 0 (f n i 2, f n i 1, f n i, f n i+1) A L 3 (1, ξ 0, ξ 2 0), (7) 1/6 0 1/6 1 1/2 1/2 1/2 1 1/2 1/3 1/2 1/6 1/6 0 1/6 5/6 1/2 1/3 1/3 1/2 1/ /6 0 1/6 5/6 1/2 1/3 1/3 1/2 1/6. 13 / 39

15 Conservative Form f n+1 i = fi n ξ 0 ((fi 1, n fi n, fi+1) n C3 L (1, ξ 0, ξ0) 2 (fi 2, n fi 1, n fi n ) C3 L (1, ξ 0, ξ0) 2 ) with C3 L = / 39

16 Conservative Form (cont.) Numerical flux: f n+1 i = f n i ξ 0 (ˆf n i+1/2 ˆf n i 1/2 ) ˆf n i+1/2 = (f n i 1, f n i, f n i+1) C L 3 (1, ξ 0, ξ 2 0) = (fi 1, n fi n, fi+1) n C3 L (:, 1) +(fi 1, n fi n, fi+1) n C3 L (:, 2)ξ 0 +(fi 1, n fi n, fi+1) n C3 L (:, 3)ξ / 39

17 WENO reconstructions on fluxes Apply WENO reconstruction on (f n i 1, f n i, f n i+1) C L 3 (:, 1) = 1 6 f i 1 n f i n f i+1 n = γ 1 ( 1 2 f i 1 n f i n ) + γ 2 ( 1 2 f i n f i+1) n with linear weights γ 1 = 1 3 and γ 2 = / 39

18 WENO reconstructions (cont.) Idea of WENO: adjust the linear weighting γ i to a nonlinear weighting w i, such that w i is very close to γ i, in the region of smooth structures, w i weights little on a non-smooth sub-stencil. 17 / 39

19 Nonlinear weights w i Smoothness indicator β i : β 1 = (f n i 1 f n i ) 2, Nonlinear weights w i : β 2 = (f n i f n i+1) 2. w 1 = γ 1 /(ɛ + β 1 ) 2, w 2 = γ 2 /(ɛ + β 2 ) 2 Normalized nonlinear weights w i : w 1 = w 1 /( w 1 + w 2 ), w 2 = w 2 /( w 1 + w 2 ) 18 / 39

20 of algorithm 1 Compute the numerical fluxes ˆf n i+1/2 compute the nonlinear weights w 1, w 2. compute numerical fluxes ˆf i+1/2 n = w 1 ( 1 2 f i 1 n f i n ) + w 2 ( 1 2 f i n f i+1) n +(fi 1, n fi n, fi+1) n C3 L (:, 2)ξ 0 +(fi 1, n fi n, fi+1) n C3 L (:, 3)ξ0 2 2 Update the solution f n+1 i f n+1 i = f n i ξ 0 (ˆf n i+1/2 ˆf n i 1/2 ) 19 / 39

21 Mass Conservation The scheme conserves the total mass, if the periodic boundary conditions are imposed. Proof. i f n+1 i = i = i = i ( ) fi n ξ 0 (ˆf n ˆf n ) i+ 1 i ξ 0 (ˆf n f n i f n i. i i+ 1 2 ˆf n ) i / 39

22 Comparison Compare with the SL method compare with the existing scheme that the integrated mass: very high spatial accuracy in multi-dimensional problem. compare with the existing scheme that the point values: mass conservation. Compare with other Eulerian approaches allows for extra large numerical time step integration, commits no error in time for one dimensional problem, but is subject to the splitting error O( t 2 ). 21 / 39

23 Extensions The SL WENO scheme has been extended to 5 th, 7 th, 9 th order in accuracy. The scheme is planned to extended to solve the -Maxwell system. The scheme is planned to couple with the adaptive mesh refinement (AMR) framework to realize spatial adaptivity. 22 / 39

24 Numerical s 23 / 39

25 u t + u x = 0 Table: Order of accuracy with u(x, t = 0) = sin(x) at T = 20. CFL = rd order 5th order 9th order mesh error order error order error order E E E E E E E E E E E E E E E E E E / 39

26 u t + u x = 0 Figure: 320 grid points, CFL = 0.6, T = / 39

27 Linear transport: u t + u x + u y = 0 Table: Order of accuracy with u(x, y, t = 0) = sin(x + y) at T = 20. CFL = rd order 5th order 9th order mesh error order error order error order E E E E E E E E E E E E E / 39

28 Linear transport: u t + u x + u y = 0 Figure: The numerical mesh is CFL = 0.6 at T = / 39

29 Rigid body rotation: u t yu x + xu y = 0 Figure: The numerical mesh is CFL = 1.2 at T = 2π. 28 / 39

30 Landau damping Consider the VP system with initial condition, f (x, v, t = 0) = 1 (1 + αcos(kx))exp( v 2 ), (8) 2π 2 29 / 39

31 Weak Landau damping: α = 0.01, k = 2 Figure: Time evolution of L 2 norm of electric field. 30 / 39

32 Weak Landau damping (cont.) Figure: Time evolution of L 1 (upper left) and L 2 (upper right) norm, discrete kinetic energy (lower left), entropy (lower right). 31 / 39

33 Strong Landau damping: α = 0.5, k = 2 Figure: Time evolution of the L 2 norm of the electric field using third, fifth, seventh and ninth order reconstruction. 32 / 39

34 Strong Landau damping (cont.) Figure: Phase space plots of strong Landau damping at T = 30 using third, fifth, seventh and ninth order reconstruction. The numerical mesh is / 39

35 Two-stream instability Consider the symmetric two stream instability, the VP system with initial condition f (x, v, t = 0) = 2 7 2π (1 + 5v 2 )(1 + α((cos(2kx) +cos(3kx))/1.2 + cos(kx))exp( v 2 2 ), with α = 0.01, k = 0.5 and the length of domain in x direction L = 2π k. 34 / 39

36 Figure: Two stream instability T = 53. The numerical mesh is / 39

37 Figure: Third order semi- WENO method. Two stream instability T = 53. The numerical mesh is (left) and (right). The computational cost is 4 and 16 times as the first plot in Figure / 39

38 Figure: Time development of numerical L 2 norm (left) and entropy (right) of two stream instability. 37 / 39

39 Equations: the VP system ology: Strang-split semi- WENO method (3rd, 5th, 7th and 9th order) s: High order schemes is more efficient than low order ones. It better preserves the energy, entropy of the system. 38 / 39

40 THANK YOU! 39 / 39

Semi-Lagrangian Formulations for Linear Advection Equations and Applications to Kinetic Equations

Semi-Lagrangian Formulations for Linear Advection Equations and Applications to Kinetic Equations Semi-Lagrangian Formulations for Linear Advection and Applications to Kinetic Department of Mathematical and Computer Science Colorado School of Mines joint work w/ Chi-Wang Shu Supported by NSF and AFOSR.

More information

Hybrid semi-lagrangian finite element-finite difference methods for the Vlasov equation

Hybrid semi-lagrangian finite element-finite difference methods for the Vlasov equation Numerical Analysis and Scientific Computing Preprint Seria Hybrid semi-lagrangian finite element-finite difference methods for the Vlasov equation W. Guo J. Qiu Preprint #21 Department of Mathematics University

More information

A High Order Conservative Semi-Lagrangian Discontinuous Galerkin Method for Two-Dimensional Transport Simulations

A High Order Conservative Semi-Lagrangian Discontinuous Galerkin Method for Two-Dimensional Transport Simulations Motivation Numerical methods Numerical tests Conclusions A High Order Conservative Semi-Lagrangian Discontinuous Galerkin Method for Two-Dimensional Transport Simulations Xiaofeng Cai Department of Mathematics

More information

Weighted ENO Schemes

Weighted ENO Schemes Xiaolei Chen Advisor: Prof. Xiaolin Li Department of Applied Mathematics and Statistics Stony Brook University, The State University of New York February 7, 014 1 3 Mapped WENO-Z Scheme 1D Scalar Hyperbolic

More information

A particle-in-cell method with adaptive phase-space remapping for kinetic plasmas

A particle-in-cell method with adaptive phase-space remapping for kinetic plasmas A particle-in-cell method with adaptive phase-space remapping for kinetic plasmas Bei Wang 1 Greg Miller 2 Phil Colella 3 1 Princeton Institute of Computational Science and Engineering Princeton University

More information

Kinetic/Fluid micro-macro numerical scheme for Vlasov-Poisson-BGK equation using particles

Kinetic/Fluid micro-macro numerical scheme for Vlasov-Poisson-BGK equation using particles Kinetic/Fluid micro-macro numerical scheme for Vlasov-Poisson-BGK equation using particles Anaïs Crestetto 1, Nicolas Crouseilles 2 and Mohammed Lemou 3. The 8th International Conference on Computational

More information

Une décomposition micro-macro particulaire pour des équations de type Boltzmann-BGK en régime de diffusion

Une décomposition micro-macro particulaire pour des équations de type Boltzmann-BGK en régime de diffusion Une décomposition micro-macro particulaire pour des équations de type Boltzmann-BGK en régime de diffusion Anaïs Crestetto 1, Nicolas Crouseilles 2 et Mohammed Lemou 3 La Tremblade, Congrès SMAI 2017 5

More information

A semi-lagrangian finite difference WENO scheme for scalar nonlinear conservation laws

A semi-lagrangian finite difference WENO scheme for scalar nonlinear conservation laws A semi-lagrangian finite difference WENO scheme for scalar nonlinear conservation laws Chieh-Sen Huang a,, Todd Arbogast b,, Chen-Hui Hung c a Department of Applied Mathematics, National Sun Yat-sen University,

More information

An asymptotic-preserving micro-macro scheme for Vlasov-BGK-like equations in the diffusion scaling

An asymptotic-preserving micro-macro scheme for Vlasov-BGK-like equations in the diffusion scaling An asymptotic-preserving micro-macro scheme for Vlasov-BGK-like equations in the diffusion scaling Anaïs Crestetto 1, Nicolas Crouseilles 2 and Mohammed Lemou 3 Saint-Malo 13 December 2016 1 Université

More information

Multi-water-bag model and method of moments for Vlasov

Multi-water-bag model and method of moments for Vlasov and method of moments for the Vlasov equation 1, Philippe Helluy 2, Nicolas Besse 3 FVCA 2011, Praha, June 6. 1 INRIA Nancy - Grand Est & University of Strasbourg - IRMA crestetto@math.unistra.fr (PhD

More information

Adaptive simulation of Vlasov equations in arbitrary dimension using interpolatory hierarchical bases

Adaptive simulation of Vlasov equations in arbitrary dimension using interpolatory hierarchical bases Adaptive simulation of Vlasov equations in arbitrary dimension using interpolatory hierarchical bases Erwan Deriaz Fusion Plasma Team Institut Jean Lamour (Nancy), CNRS / Université de Lorraine VLASIX

More information

Consistency analysis of a 1D Finite Volume scheme for barotropic Euler models

Consistency analysis of a 1D Finite Volume scheme for barotropic Euler models Consistency analysis of a 1D Finite Volume scheme for barotropic Euler models F Berthelin 1,3, T Goudon 1,3, and S Mineaud,3 1 Inria, Sophia Antipolis Méditerranée Research Centre, Proect COFFEE Inria,

More information

Benchmarks in Computational Plasma Physics

Benchmarks in Computational Plasma Physics Benchmarks in Computational Plasma Physics P. Londrillo INAF, Bologna, Italie S. Landi Università di Firenze, Italie What you compute when you do computations of the Vlasov equation? Overview A short review

More information

1 Introduction and Notations he simplest model to describe a hot dilute electrons moving in a fixed ion background is the following one dimensional Vl

1 Introduction and Notations he simplest model to describe a hot dilute electrons moving in a fixed ion background is the following one dimensional Vl Numerical Study on Landau Damping ie Zhou 1 School of Mathematical Sciences Peking University, Beijing 100871, China Yan Guo 2 Lefschetz Center for Dynamical Systems Division of Applied Mathematics Brown

More information

Inverse Lax-Wendroff Procedure for Numerical Boundary Conditions of. Conservation Laws 1. Abstract

Inverse Lax-Wendroff Procedure for Numerical Boundary Conditions of. Conservation Laws 1. Abstract Inverse Lax-Wendroff Procedure for Numerical Boundary Conditions of Conservation Laws Sirui Tan and Chi-Wang Shu 3 Abstract We develop a high order finite difference numerical boundary condition for solving

More information

Mixed semi-lagrangian/finite difference methods for plasma simulations

Mixed semi-lagrangian/finite difference methods for plasma simulations Mixed semi-lagrangian/finite difference methods for plasma simulations Francis Filbet, Chang Yang To cite this version: Francis Filbet, Chang Yang. Mixed semi-lagrangian/finite difference methods for plasma

More information

A Central Compact-Reconstruction WENO Method for Hyperbolic Conservation Laws

A Central Compact-Reconstruction WENO Method for Hyperbolic Conservation Laws A Central Compact-Reconstruction WENO Method for Hyperbolic Conservation Laws Kilian Cooley 1 Prof. James Baeder 2 1 Department of Mathematics, University of Maryland - College Park 2 Department of Aerospace

More information

Numerical Solutions for Hyperbolic Systems of Conservation Laws: from Godunov Method to Adaptive Mesh Refinement

Numerical Solutions for Hyperbolic Systems of Conservation Laws: from Godunov Method to Adaptive Mesh Refinement Numerical Solutions for Hyperbolic Systems of Conservation Laws: from Godunov Method to Adaptive Mesh Refinement Romain Teyssier CEA Saclay Romain Teyssier 1 Outline - Euler equations, MHD, waves, hyperbolic

More information

Fourier analysis for discontinuous Galerkin and related methods. Abstract

Fourier analysis for discontinuous Galerkin and related methods. Abstract Fourier analysis for discontinuous Galerkin and related methods Mengping Zhang and Chi-Wang Shu Abstract In this paper we review a series of recent work on using a Fourier analysis technique to study the

More information

A numerical study of SSP time integration methods for hyperbolic conservation laws

A numerical study of SSP time integration methods for hyperbolic conservation laws MATHEMATICAL COMMUNICATIONS 613 Math. Commun., Vol. 15, No., pp. 613-633 (010) A numerical study of SSP time integration methods for hyperbolic conservation laws Nelida Črnjarić Žic1,, Bojan Crnković 1

More information

ENO and WENO schemes. Further topics and time Integration

ENO and WENO schemes. Further topics and time Integration ENO and WENO schemes. Further topics and time Integration Tefa Kaisara CASA Seminar 29 November, 2006 Outline 1 Short review ENO/WENO 2 Further topics Subcell resolution Other building blocks 3 Time Integration

More information

Nhung Pham 1, Philippe Helluy 2 and Laurent Navoret 3

Nhung Pham 1, Philippe Helluy 2 and Laurent Navoret 3 ESAIM: PROCEEDINGS AND SURVEYS, September 014, Vol. 45, p. 379-389 J.-S. Dhersin, Editor HYPERBOLIC APPROXIMATION OF THE FOURIER TRANSFORMED VLASOV EQUATION Nhung Pham 1, Philippe Helluy and Laurent Navoret

More information

Block-Structured Adaptive Mesh Refinement

Block-Structured Adaptive Mesh Refinement Block-Structured Adaptive Mesh Refinement Lecture 2 Incompressible Navier-Stokes Equations Fractional Step Scheme 1-D AMR for classical PDE s hyperbolic elliptic parabolic Accuracy considerations Bell

More information

ICES REPORT A Multilevel-WENO Technique for Solving Nonlinear Conservation Laws

ICES REPORT A Multilevel-WENO Technique for Solving Nonlinear Conservation Laws ICES REPORT 7- August 7 A Multilevel-WENO Technique for Solving Nonlinear Conservation Laws by Todd Arbogast, Chieh-Sen Huang, and Xikai Zhao The Institute for Computational Engineering and Sciences The

More information

Gyrokinetic simulations of magnetic fusion plasmas

Gyrokinetic simulations of magnetic fusion plasmas Gyrokinetic simulations of magnetic fusion plasmas Tutorial 2 Virginie Grandgirard CEA/DSM/IRFM, Association Euratom-CEA, Cadarache, 13108 St Paul-lez-Durance, France. email: virginie.grandgirard@cea.fr

More information

Extremum-Preserving Limiters for MUSCL and PPM

Extremum-Preserving Limiters for MUSCL and PPM arxiv:0903.400v [physics.comp-ph] 7 Mar 009 Extremum-Preserving Limiters for MUSCL and PPM Michael Sekora Program in Applied and Computational Mathematics, Princeton University Princeton, NJ 08540, USA

More information

Une décomposition micro-macro particulaire pour des équations de type Boltzmann-BGK en régime de diffusion

Une décomposition micro-macro particulaire pour des équations de type Boltzmann-BGK en régime de diffusion Une décomposition micro-macro particulaire pour des équations de type Boltzmann-BGK en régime de diffusion Anaïs Crestetto 1, Nicolas Crouseilles 2 et Mohammed Lemou 3 Rennes, 14ème Journée de l équipe

More information

Exponential Recursion for Multi-Scale Problems in Electromagnetics

Exponential Recursion for Multi-Scale Problems in Electromagnetics Exponential Recursion for Multi-Scale Problems in Electromagnetics Matthew F. Causley Department of Mathematics Kettering University Computational Aspects of Time Dependent Electromagnetic Wave Problems

More information

Integration of Vlasov-type equations

Integration of Vlasov-type equations Alexander Ostermann University of Innsbruck, Austria Joint work with Lukas Einkemmer Verona, April/May 2017 Plasma the fourth state of matter 99% of the visible matter in the universe is made of plasma

More information

Michel Mehrenberger 1 & Eric Sonnendrücker 2 ECCOMAS 2016

Michel Mehrenberger 1 & Eric Sonnendrücker 2 ECCOMAS 2016 for Vlasov type for Vlasov type 1 2 ECCOMAS 2016 In collaboration with : Bedros Afeyan, Aurore Back, Fernando Casas, Nicolas Crouseilles, Adila Dodhy, Erwan Faou, Yaman Güclü, Adnane Hamiaz, Guillaume

More information

Moments conservation in adaptive Vlasov solver

Moments conservation in adaptive Vlasov solver 12 Moments conservation in adaptive Vlasov solver M. Gutnic a,c, M. Haefele b,c and E. Sonnendrücker a,c a IRMA, Université Louis Pasteur, Strasbourg, France. b LSIIT, Université Louis Pasteur, Strasbourg,

More information

Chapter 17. Finite Volume Method The partial differential equation

Chapter 17. Finite Volume Method The partial differential equation Chapter 7 Finite Volume Method. This chapter focusses on introducing finite volume method for the solution of partial differential equations. These methods have gained wide-spread acceptance in recent

More information

Kinetic/Fluid micro-macro numerical scheme for Vlasov-Poisson-BGK equation using particles

Kinetic/Fluid micro-macro numerical scheme for Vlasov-Poisson-BGK equation using particles Kinetic/Fluid micro-macro numerical scheme for Vlasov-Poisson-BGK equation using particles Anaïs Crestetto 1, Nicolas Crouseilles 2 and Mohammed Lemou 3. Workshop Asymptotic-Preserving schemes, Porquerolles.

More information

ON THE VLASOV-MAXWELL SYSTEM WITH A STRONG EXTERNAL MAGNETIC FIELD

ON THE VLASOV-MAXWELL SYSTEM WITH A STRONG EXTERNAL MAGNETIC FIELD ON THE VLASOV-MAXWELL SYSTEM WITH A STONG EXTENAL MAGNETIC FIELD Francis Filbet, Tao Xiong, Eric Sonnendr ucker To cite this version: Francis Filbet, Tao Xiong, Eric Sonnendr ucker. ON THE VLASOV-MAXWELL

More information

Hierarchical Reconstruction with up to Second Degree Remainder for Solving Nonlinear Conservation Laws

Hierarchical Reconstruction with up to Second Degree Remainder for Solving Nonlinear Conservation Laws Hierarchical Reconstruction with up to Second Degree Remainder for Solving Nonlinear Conservation Laws Dedicated to Todd F. Dupont on the occasion of his 65th birthday Yingjie Liu, Chi-Wang Shu and Zhiliang

More information

Summer College on Plasma Physics. 30 July - 24 August, The particle-in-cell simulation method: Concept and limitations

Summer College on Plasma Physics. 30 July - 24 August, The particle-in-cell simulation method: Concept and limitations 1856-30 2007 Summer College on Plasma Physics 30 July - 24 August, 2007 The particle-in-cell M. E. Dieckmann Institut fuer Theoretische Physik IV, Ruhr-Universitaet, Bochum, Germany The particle-in-cell

More information

An Improved Non-linear Weights for Seventh-Order WENO Scheme

An Improved Non-linear Weights for Seventh-Order WENO Scheme An Improved Non-linear Weights for Seventh-Order WENO Scheme arxiv:6.06755v [math.na] Nov 06 Samala Rathan, G Naga Raju Department of Mathematics, Visvesvaraya National Institute of Technology, Nagpur,

More information

High-Order Finite-Volume Methods! Phillip Colella! Computational Research Division! Lawrence Berkeley National Laboratory!

High-Order Finite-Volume Methods! Phillip Colella! Computational Research Division! Lawrence Berkeley National Laboratory! High-Order Finite-Volume Methods! Phillip Colella! Computational Research Division! Lawrence Berkeley National Laboratory! Why Higher Order?! Locally-refined grids, mapped-multiblock grids smooth except

More information

Computational Methods in Plasma Physics

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

More information

A charge preserving scheme for the numerical resolution of the Vlasov-Ampère equations.

A charge preserving scheme for the numerical resolution of the Vlasov-Ampère equations. A charge preserving scheme for the numerical resolution of the Vlasov-Ampère equations. Nicolas Crouseilles Thomas Respaud January, Abstract In this report, a charge preserving numerical resolution of

More information

Weighted Essentially Non-Oscillatory limiters for Runge-Kutta Discontinuous Galerkin Methods

Weighted Essentially Non-Oscillatory limiters for Runge-Kutta Discontinuous Galerkin Methods Weighted Essentially Non-Oscillatory limiters for Runge-Kutta Discontinuous Galerkin Methods Jianxian Qiu School of Mathematical Science Xiamen University jxqiu@xmu.edu.cn http://ccam.xmu.edu.cn/teacher/jxqiu

More information

SMOOTHNESS INDICATORS FOR WENO SCHEME USING UNDIVIDED DIFFERENCES

SMOOTHNESS INDICATORS FOR WENO SCHEME USING UNDIVIDED DIFFERENCES Proceedings of ALGORITMY 2016 pp. 155 164 SMOOTHNESS INDICATORS FOR WENO SCHEME USING UNDIVIDED DIFFERENCES TAMER H. M. A. KASEM AND FRANÇOIS G. SCHMITT Abstract. The weighted essentially non-oscillatory

More information

Adaptive semi-lagrangian schemes for transport

Adaptive semi-lagrangian schemes for transport for transport (how to predict accurate grids?) Martin Campos Pinto CNRS & University of Strasbourg, France joint work Albert Cohen (Paris 6), Michel Mehrenberger and Eric Sonnendrücker (Strasbourg) MAMCDP

More information

arxiv: v2 [math.na] 4 Mar 2014

arxiv: v2 [math.na] 4 Mar 2014 Finite Difference Weighted Essentially Non-Oscillatory Schemes with Constrained Transport for Ideal Magnetohydrodynamics arxiv:1309.3344v [math.na] 4 Mar 014 Andrew J. Christlieb a, James A. Rossmanith

More information

A re-averaged WENO reconstruction and a third order CWENO scheme for hyperbolic conservation laws

A re-averaged WENO reconstruction and a third order CWENO scheme for hyperbolic conservation laws A re-averaged WENO reconstruction and a third order CWENO scheme for hyperbolic conservation laws Chieh-Sen Huang a,, Todd Arbogast b,, Chen-Hui Hung c,3 a Department of Applied Mathematics and National

More information

The RAMSES code and related techniques I. Hydro solvers

The RAMSES code and related techniques I. Hydro solvers The RAMSES code and related techniques I. Hydro solvers Outline - The Euler equations - Systems of conservation laws - The Riemann problem - The Godunov Method - Riemann solvers - 2D Godunov schemes -

More information

Improvement of convergence to steady state solutions of Euler equations with. the WENO schemes. Abstract

Improvement of convergence to steady state solutions of Euler equations with. the WENO schemes. Abstract Improvement of convergence to steady state solutions of Euler equations with the WENO schemes Shuhai Zhang, Shufen Jiang and Chi-Wang Shu 3 Abstract The convergence to steady state solutions of the Euler

More information

DISCONTINOUS GALERKIN METHODS FOR VLASOV MODELS OF PLASMA

DISCONTINOUS GALERKIN METHODS FOR VLASOV MODELS OF PLASMA DISCONTINOUS GALERKIN METHODS FOR VLASOV MODELS OF PLASMA By David C. Seal A dissertation submitted in partial fulfillment of the requirements for the degree of Doctor of Philosophy (Mathematics) at the

More information

Energy-Conserving Numerical Simulations of Electron Holes in Two-Species Plasmas

Energy-Conserving Numerical Simulations of Electron Holes in Two-Species Plasmas Energy-Conserving Numerical Simulations of Electron Holes in Two-Species Plasmas Yingda Cheng Andrew J. Christlieb Xinghui Zhong March 18, 2014 Abstract In this paper, we apply our recently developed energy-conserving

More information

Nonlinear Diffusion. Journal Club Presentation. Xiaowei Zhou

Nonlinear Diffusion. Journal Club Presentation. Xiaowei Zhou 1 / 41 Journal Club Presentation Xiaowei Zhou Department of Electronic and Computer Engineering The Hong Kong University of Science and Technology 2009-12-11 2 / 41 Outline 1 Motivation Diffusion process

More information

An Eulerian-Lagrangian WENO Scheme for Nonlinear Conservation Laws

An Eulerian-Lagrangian WENO Scheme for Nonlinear Conservation Laws An Eulerian-Lagrangian WENO Scheme for Nonlinear Conservation Laws Chieh-Sen Huang a,, Todd Arbogast b, a Department of Applied Mathematics, National Sun Yat-sen University, Kaohsiung 84, Taiwan, R.O.C.

More information

Micro-macro methods for Boltzmann-BGK-like equations in the diffusion scaling

Micro-macro methods for Boltzmann-BGK-like equations in the diffusion scaling Micro-macro methods for Boltzmann-BGK-like equations in the diffusion scaling Anaïs Crestetto 1, Nicolas Crouseilles 2, Giacomo Dimarco 3 et Mohammed Lemou 4 Saint-Malo, 14 décembre 2017 1 Université de

More information

A high order adaptive finite element method for solving nonlinear hyperbolic conservation laws

A high order adaptive finite element method for solving nonlinear hyperbolic conservation laws A high order adaptive finite element method for solving nonlinear hyperbolic conservation laws Zhengfu Xu, Jinchao Xu and Chi-Wang Shu 0th April 010 Abstract In this note, we apply the h-adaptive streamline

More information

EXASCALE COMPUTING. Implementation of a 2D Electrostatic Particle in Cell algorithm in UniÞed Parallel C with dynamic load-balancing

EXASCALE COMPUTING. Implementation of a 2D Electrostatic Particle in Cell algorithm in UniÞed Parallel C with dynamic load-balancing ExaScience Lab Intel Labs Europe EXASCALE COMPUTING Implementation of a 2D Electrostatic Particle in Cell algorithm in UniÞed Parallel C with dynamic load-balancing B. Verleye P. Henry R. Wuyts G. Lapenta

More information

Dedicated to the 70th birthday of Professor Lin Qun

Dedicated to the 70th birthday of Professor Lin Qun Journal of Computational Mathematics, Vol.4, No.3, 6, 39 5. ANTI-DIFFUSIVE FINITE DIFFERENCE WENO METHODS FOR SHALLOW WATER WITH TRANSPORT OF POLLUTANT ) Zhengfu Xu (Department of Mathematics, Pennsylvania

More information

Fifth order multi-moment WENO schemes for hyperbolic conservation laws

Fifth order multi-moment WENO schemes for hyperbolic conservation laws J. Sci. Comput. manuscript No. (will be inserted by the editor) Fifth order multi-moment WENO schemes for hyperbolic conservation laws Chieh-Sen Huang Feng Xiao Todd Arbogast Received: May 24 / Accepted:

More information

A Discontinuous Galerkin Method for Vlasov Systems

A Discontinuous Galerkin Method for Vlasov Systems A Discontinuous Galerkin Method for Vlasov Systems P. J. Morrison Department of Physics and Institute for Fusion Studies The University of Texas at Austin morrison@physics.utexas.edu http://www.ph.utexas.edu/

More information

A High Order WENO Scheme for a Hierarchical Size-Structured Model. Abstract

A High Order WENO Scheme for a Hierarchical Size-Structured Model. Abstract A High Order WENO Scheme for a Hierarchical Size-Structured Model Jun Shen 1, Chi-Wang Shu 2 and Mengping Zhang 3 Abstract In this paper we develop a high order explicit finite difference weighted essentially

More information

Numerical Simulations. Duncan Christie

Numerical Simulations. Duncan Christie Numerical Simulations Duncan Christie Motivation There isn t enough time to derive the necessary methods to do numerical simulations, but there is enough time to survey what methods and codes are available

More information

Massively parallel semi-lagrangian solution of the 6d Vlasov-Poisson problem

Massively parallel semi-lagrangian solution of the 6d Vlasov-Poisson problem Massively parallel semi-lagrangian solution of the 6d Vlasov-Poisson problem Katharina Kormann 1 Klaus Reuter 2 Markus Rampp 2 Eric Sonnendrücker 1 1 Max Planck Institut für Plasmaphysik 2 Max Planck Computing

More information

A Hamiltonian Numerical Scheme for Large Scale Geophysical Fluid Systems

A Hamiltonian Numerical Scheme for Large Scale Geophysical Fluid Systems A Hamiltonian Numerical Scheme for Large Scale Geophysical Fluid Systems Bob Peeters Joint work with Onno Bokhove & Jason Frank TW, University of Twente, Enschede CWI, Amsterdam PhD-TW colloquium, 9th

More information

Adaptive WENO Schemes for Singular in Space and Time Solutions of Nonlinear Degenerate Reaction-Diffusion Problems

Adaptive WENO Schemes for Singular in Space and Time Solutions of Nonlinear Degenerate Reaction-Diffusion Problems EPJ Web of Conferences 108, 0019 (016) DOI: 10.1051/ epjconf/ 0161080019 C Owned by the authors, published by EDP Sciences, 016 Adaptive WENO Schemes for Singular in Space and Time Solutions of Nonlinear

More information

A general well-balanced finite volume scheme for Euler equations with gravity

A general well-balanced finite volume scheme for Euler equations with gravity A general well-balanced finite volume scheme for Euler equations with gravity Jonas P. Berberich, Praveen Chandrashekar, Christian Klingenberg Abstract We present a second order well-balanced Godunov-type

More information

Kinetic theory of gases

Kinetic theory of gases Kinetic theory of gases Toan T. Nguyen Penn State University http://toannguyen.org http://blog.toannguyen.org Graduate Student seminar, PSU Jan 19th, 2017 Fall 2017, I teach a graduate topics course: same

More information

Strong Stability-Preserving (SSP) High-Order Time Discretization Methods

Strong Stability-Preserving (SSP) High-Order Time Discretization Methods Strong Stability-Preserving (SSP) High-Order Time Discretization Methods Xinghui Zhong 12/09/ 2009 Outline 1 Introduction Why SSP methods Idea History/main reference 2 Explicit SSP Runge-Kutta Methods

More information

A Fourth-Order Central Runge-Kutta Scheme for Hyperbolic Conservation Laws

A Fourth-Order Central Runge-Kutta Scheme for Hyperbolic Conservation Laws A Fourth-Order Central Runge-Kutta Scheme for Hyperbolic Conservation Laws Mehdi Dehghan, Rooholah Jazlanian Department of Applied Mathematics, Faculty of Mathematics and Computer Science, Amirkabir University

More information

A parametrized maximum principle preserving flux limiter for finite difference RK-WENO schemes with applications in incompressible flows.

A parametrized maximum principle preserving flux limiter for finite difference RK-WENO schemes with applications in incompressible flows. A parametrized maximum principle preserving flux limiter for finite difference RK-WENO schemes with applications in incompressible flows Tao Xiong Jing-ei Qiu Zhengfu Xu 3 Abstract In Xu [] a class of

More information

30 crete maximum principle, which all imply the bound-preserving property. But most

30 crete maximum principle, which all imply the bound-preserving property. But most 3 4 7 8 9 3 4 7 A HIGH ORDER ACCURATE BOUND-PRESERVING COMPACT FINITE DIFFERENCE SCHEME FOR SCALAR CONVECTION DIFFUSION EQUATIONS HAO LI, SHUSEN XIE, AND XIANGXIONG ZHANG Abstract We show that the classical

More information

A New Fourth-Order Non-Oscillatory Central Scheme For Hyperbolic Conservation Laws

A New Fourth-Order Non-Oscillatory Central Scheme For Hyperbolic Conservation Laws A New Fourth-Order Non-Oscillatory Central Scheme For Hyperbolic Conservation Laws A. A. I. Peer a,, A. Gopaul a, M. Z. Dauhoo a, M. Bhuruth a, a Department of Mathematics, University of Mauritius, Reduit,

More information

Direct Sum. McKelvey, and Madie Wilkin Adviser: Dr. Andrew Christlieb Co-advisers: Eric Wolf and Justin Droba. July 23, Michigan St.

Direct Sum. McKelvey, and Madie Wilkin Adviser: Dr. Andrew Christlieb Co-advisers: Eric Wolf and Justin Droba. July 23, Michigan St. and Adviser: Dr. Andrew Christlieb Co-advisers: Eric Wolf and Justin Droba Michigan St. University July 23, 2014 The N-Body Problem Solar systems The N-Body Problem Solar systems Interacting charges, gases

More information

Modeling using conservation laws. Let u(x, t) = density (heat, momentum, probability,...) so that. u dx = amount in region R Ω. R

Modeling using conservation laws. Let u(x, t) = density (heat, momentum, probability,...) so that. u dx = amount in region R Ω. R Modeling using conservation laws Let u(x, t) = density (heat, momentum, probability,...) so that u dx = amount in region R Ω. R Modeling using conservation laws Let u(x, t) = density (heat, momentum, probability,...)

More information

Continuous Gradient Method to Cell Crossing Instability

Continuous Gradient Method to Cell Crossing Instability Continuous Gradient Method to Cell Crossing Instability D. Z. Zhang X. Ma P. T. Giguere Fluid Dynamics and Solid Mechanics Group, T-3, Theoretical Division Los Alamos National Laboratory Los Alamos, New

More information

A PARTICLE-IN-CELL METHOD FOR THE SIMULATION OF PLASMAS BASED ON AN UNCONDITIONALLY STABLE WAVE EQUATION SOLVER. Eric Matthew Wolf

A PARTICLE-IN-CELL METHOD FOR THE SIMULATION OF PLASMAS BASED ON AN UNCONDITIONALLY STABLE WAVE EQUATION SOLVER. Eric Matthew Wolf A PARTICLE-IN-CELL METHOD FOR THE SIMULATION OF PLASMAS BASED ON AN UNCONDITIONALLY STABLE WAVE EQUATION SOLVER By Eric Matthew Wolf A DISSERTATION Submitted to Michigan State University in partial fulfillment

More information

Multiscale method and pseudospectral simulations for linear viscoelastic incompressible flows

Multiscale method and pseudospectral simulations for linear viscoelastic incompressible flows Interaction and Multiscale Mechanics, Vol. 5, No. 1 (2012) 27-40 27 Multiscale method and pseudospectral simulations for linear viscoelastic incompressible flows Ling Zhang and Jie Ouyang* Department of

More information

Calculating Accurate Waveforms for LIGO and LISA Data Analysis

Calculating Accurate Waveforms for LIGO and LISA Data Analysis Calculating Accurate Waveforms for LIGO and LISA Data Analysis Lee Lindblom Theoretical Astrophysics, Caltech HEPL-KIPAC Seminar, Stanford 17 November 2009 Results from the Caltech/Cornell Numerical Relativity

More information

Asymptotic-Preserving Particle-In-Cell method for the Vlasov-Poisson system near quasineutrality

Asymptotic-Preserving Particle-In-Cell method for the Vlasov-Poisson system near quasineutrality Asymptotic-Preserving Particle-In-Cell method for the Vlasov-Poisson system near quasineutrality Pierre Degond 1, Fabrice Deluzet 2, Laurent Navoret 3, An-Bang Sun 4, Marie-Hélène Vignal 5 1 Université

More information

Krylov Implicit Integration Factor Methods for Semilinear Fourth-Order Equations

Krylov Implicit Integration Factor Methods for Semilinear Fourth-Order Equations mathematics Article Krylov Implicit Integration Factor Methods for Semilinear Fourth-Order Equations Michael Machen and Yong-Tao Zhang * Department of Applied and Computational Mathematics and Statistics,

More information

Simulating experiments for ultra-intense laser-vacuum interaction

Simulating experiments for ultra-intense laser-vacuum interaction Simulating experiments for ultra-intense laser-vacuum interaction Nina Elkina LMU München, Germany March 11, 2011 Simulating experiments for ultra-intense laser-vacuum interaction March 11, 2011 1 / 23

More information

arxiv: v2 [math.na] 5 Jul 2016

arxiv: v2 [math.na] 5 Jul 2016 AN ASYMPTOTIC PRESERVING SCHEME FOR THE RELATIVISTIC VLASOV MAXWELL EQUATIONS IN THE CLASSICAL LIMIT by arxiv:1602.09062v2 [math.na] 5 Jul 2016 Nicolas Crouseilles, Lukas Einkemmer & Erwan Faou Abstract.

More information

Solving Boundary Value Problems with Homotopy Continuation

Solving Boundary Value Problems with Homotopy Continuation Solving Boundary Value Problems with Homotopy Continuation Gene Allgower Colorado State University Andrew Sommese University of Notre Dame Dan Bates University of Notre Dame Charles Wampler GM Research

More information

Gradient Flows: Qualitative Properties & Numerical Schemes

Gradient Flows: Qualitative Properties & Numerical Schemes Gradient Flows: Qualitative Properties & Numerical Schemes J. A. Carrillo Imperial College London RICAM, December 2014 Outline 1 Gradient Flows Models Gradient flows Evolving diffeomorphisms 2 Numerical

More information

A Multi-Dimensional Limiter for Hybrid Grid

A Multi-Dimensional Limiter for Hybrid Grid APCOM & ISCM 11-14 th December, 2013, Singapore A Multi-Dimensional Limiter for Hybrid Grid * H. W. Zheng ¹ 1 State Key Laboratory of High Temperature Gas Dynamics, Institute of Mechanics, Chinese Academy

More information

A DISCONTINUOUS GALERKIN FINITE ELEMENT METHOD FOR TIME DEPENDENT PARTIAL DIFFERENTIAL EQUATIONS WITH HIGHER ORDER DERIVATIVES

A DISCONTINUOUS GALERKIN FINITE ELEMENT METHOD FOR TIME DEPENDENT PARTIAL DIFFERENTIAL EQUATIONS WITH HIGHER ORDER DERIVATIVES MATHEMATCS OF COMPUTATON Volume 77, Number 6, April 008, Pages 699 730 S 005-5718(07)0045-5 Article electronically published on September 6, 007 A DSCONTNUOUS GALERKN FNTE ELEMENT METHOD FOR TME DEPENDENT

More information

Earth System Modeling Domain decomposition

Earth System Modeling Domain decomposition Earth System Modeling Domain decomposition Graziano Giuliani International Centre for Theorethical Physics Earth System Physics Section Advanced School on Regional Climate Modeling over South America February

More information

MHD RELATED TO 2-FLUID THEORY, KINETIC THEORY AND MAGANETIC RECONNECTION

MHD RELATED TO 2-FLUID THEORY, KINETIC THEORY AND MAGANETIC RECONNECTION MHD RELATED TO 2-FLUID THEORY, KINETIC THEORY AND MAGANETIC RECONNECTION Marty Goldman University of Colorado Spring 2017 Physics 5150 Issues 2 How is MHD related to 2-fluid theory Level of MHD depends

More information

Conservative semi-lagrangian schemes for Vlasov equations

Conservative semi-lagrangian schemes for Vlasov equations Conservative semi-lagrangian schemes for Vlasov equations Nicolas Crouseilles Michel Mehrenberger Eric Sonnendrücker October 3, 9 Abstract Conservative methods for the numerical solution of the Vlasov

More information

Anti-diffusive finite difference WENO methods for shallow water with. transport of pollutant

Anti-diffusive finite difference WENO methods for shallow water with. transport of pollutant Anti-diffusive finite difference WENO methods for shallow water with transport of pollutant Zhengfu Xu 1 and Chi-Wang Shu 2 Dedicated to Professor Qun Lin on the occasion of his 70th birthday Abstract

More information

Berk-Breizman and diocotron instability testcases

Berk-Breizman and diocotron instability testcases Berk-Breizman and diocotron instability testcases M. Mehrenberger, N. Crouseilles, V. Grandgirard, S. Hirstoaga, E. Madaule, J. Petri, E. Sonnendrücker Université de Strasbourg, IRMA (France); INRIA Grand

More information

of Nebraska - Lincoln. National Aeronautics and Space Administration

of Nebraska - Lincoln. National Aeronautics and Space Administration University of Nebraska - Lincoln DigitalCommons@University of Nebraska - Lincoln NASA Publications National Aeronautics and Space Administration 2013 Corrigendum to Spurious behavior of shockcapturing

More information

Hierarchical Reconstruction with up to Second Degree Remainder for Solving Nonlinear Conservation Laws

Hierarchical Reconstruction with up to Second Degree Remainder for Solving Nonlinear Conservation Laws Hierarchical Reconstruction with up to Second Degree Remainder for Solving Nonlinear Conservation Laws Dedicated to Todd F. Dupont on the occasion of his 65th birthday Yingjie Liu, Chi-Wang Shu and Zhiliang

More information

Math 660-Lecture 23: Gudonov s method and some theories for FVM schemes

Math 660-Lecture 23: Gudonov s method and some theories for FVM schemes Math 660-Lecture 3: Gudonov s method and some theories for FVM schemes 1 The idea of FVM (You can refer to Chapter 4 in the book Finite volume methods for hyperbolic problems ) Consider the box [x 1/,

More information

Domain-decomposed Fully Coupled Implicit Methods for a Magnetohydrodynamics Problem

Domain-decomposed Fully Coupled Implicit Methods for a Magnetohydrodynamics Problem Domain-decomposed Fully Coupled Implicit Methods for a Magnetohydrodynamics Problem Serguei Ovtchinniov 1, Florin Dobrian 2, Xiao-Chuan Cai 3, David Keyes 4 1 University of Colorado at Boulder, Department

More information

Bernstein-Greene-Kruskal (BGK) Modes in a Three Dimensional Unmagnetized Plasma

Bernstein-Greene-Kruskal (BGK) Modes in a Three Dimensional Unmagnetized Plasma Bernstein-Greene-Kruskal (BGK) Modes in a Three Dimensional Unmagnetized Plasma C. S. Ng & A. Bhattacharjee Space Science Center University of New Hampshire Space Science Center Seminar, March 9, 2005

More information

Sheath stability conditions for PIC simulation

Sheath stability conditions for PIC simulation Plasma_conference (2011/11/24,Kanazawa,Japan) PIC Sheath stability conditions for PIC simulation Osaka Prefecture. University H. Matsuura, and N. Inagaki, Background Langmuir probe is the most old but

More information

A Bound-Preserving Fourth Order Compact Finite Difference Scheme for Scalar Convection Diffusion Equations

A Bound-Preserving Fourth Order Compact Finite Difference Scheme for Scalar Convection Diffusion Equations A Bound-Preserving Fourth Order Compact Finite Difference Scheme for Scalar Convection Diffusion Equations Hao Li Math Dept, Purdue Univeristy Ocean University of China, December, 2017 Joint work with

More information

EN Nonlinear Control and Planning in Robotics Lecture 10: Lyapunov Redesign and Robust Backstepping April 6, 2015

EN Nonlinear Control and Planning in Robotics Lecture 10: Lyapunov Redesign and Robust Backstepping April 6, 2015 EN530.678 Nonlinear Control and Planning in Robotics Lecture 10: Lyapunov Redesign and Robust Backstepping April 6, 2015 Prof: Marin Kobilarov 1 Uncertainty and Lyapunov Redesign Consider the system [1]

More information

Hybrid Simulation Method ISSS-10 Banff 2011

Hybrid Simulation Method ISSS-10 Banff 2011 Hybrid Simulation Method ISSS-10 Banff 2011 David Burgess Astronomy Unit Queen Mary University of London With thanks to Dietmar Krauss-Varban Space Plasmas: From Sun to Earth Space Plasma Plasma is (mostly)

More information

Landau Damping Simulation Models

Landau Damping Simulation Models Landau Damping Simulation Models Hua-sheng XIE (u) huashengxie@gmail.com) Department of Physics, Institute for Fusion Theory and Simulation, Zhejiang University, Hangzhou 310027, P.R.China Oct. 9, 2013

More information

A genuinely high order total variation diminishing scheme for one-dimensional. scalar conservation laws 1. Abstract

A genuinely high order total variation diminishing scheme for one-dimensional. scalar conservation laws 1. Abstract A genuinely high order total variation diminishing scheme for one-dimensional scalar conservation laws Xiangxiong Zhang and Chi-Wang Shu 3 Abstract It is well known that finite difference or finite volume

More information

A FV Scheme for Maxwell s equations

A FV Scheme for Maxwell s equations A FV Scheme for Maxwell s equations Convergence Analysis on unstructured meshes Stephanie Lohrengel * Malika Remaki ** *Laboratoire J.A. Dieudonné (UMR CNRS 6621), Université de Nice Sophia Antipolis,

More information