A fully implicit, exactly conserving algorithm for multidimensional particle-in-cell kinetic simulations

Size: px
Start display at page:

Download "A fully implicit, exactly conserving algorithm for multidimensional particle-in-cell kinetic simulations"

Transcription

1 A fully implicit, exactly conserving algorithm for multidimensional particle-in-cell kinetic simulations L. Chacón Applied Mathematics and Plasma Physics Group Theoretical Division Los Alamos National Laboratory P.O. Box 1663, Los Alamos, NM Other collaborators: G. Chen, W. Taitano, D. A. Knoll (LANL) D. C. Barnes (Coronado Consulting) Numerical Methods for Large-Scale Nonlinear Problems and Their Applications Aug 31-Sept 4, 215 ICERM, Brown U. Providence, RI Work funded by DOE-SC ASCR, and the LANL and ORNL LDRD programs

2 Outline Particle-in-cell (PIC) methods for plasmas Explicit vs. implicit PIC Preconditioned JFNK 1D ES implicit PIC Multirate implicit time integrator (particle subcycling) Moment-based preconditioning Generalization to Curvilinear Multi-D EM PIC: Vlasov-Darwin model Review and motivation for Darwin model Conservation properties (energy, charge, and canonical momenta) Numerical benchmarks

3 Introduction

4 Kinetic Plasma Simulation A fully ionized collisionless plasma: ions, electrons, and electromagnetic fields Challenge: integrate electron-ion-field kinetic system on an ion time-scale and a system length scale while retaining electron kinetic effects accurately. (We are developing a new implicit algorithm for long-term, system-scale simulations. ) Problem features a hierarchical description: How to design a multiscale algorithm? How to respect conservation laws, and constraints?

5 Particle-in-cell (PIC) methods for kinetic plasma simulation t f + v f + F m v f = Lagrangian solution by the method of characteristics: f (x, v, t) = f (x t dtv, v 1 m t ) dtf ; x(t = ) = x ; v(t = ) = v PIC approach follows characteristics employing macroparticles (volumes in phase space) f (x, v, t) = p δ(x x p )δ(v v p ) t B + E = ẋ p = v p v p = q p m p (E + v B) µ ɛ t E + B = µ j B = E = ρ ɛ δ(x x p ) S(x x p ) ; E p = i E i S(x i x p ) ; j i = p j p S(x i x p )

6 State-of-the-art classical PIC algorithm is explicit Classical explicit PIC: leap-frogs particle positions and velocities, field-solve at position update: Implementation is straightforward, but... Performance limitations: CFL-type instability: min(ω pe t < 1, c t < x). Minimum temporal resolution Finite-grid instability: x < λ Debye. Minimum spatial resolution Memory bound: challenging for efficient use of modern computer architectures. Accuracy limitations: Lack of energy conservation, problematic for long-time-scale simulations To remove the stability/accuracy constraints of explicit methods, we consider implicit methods.

7 Implicit PIC methods Exploration of implicit PIC started in the 198s Implicit moment method 1 Direct implicit method 2 Early approaches used linearized, semi-implicit formulations: Lack of nonlinear convergence Particle orbit accuracy (particle and fields integrated in lock-step) Inconsistencies between particles and moments Inaccuracies! Plasma self-heating/cooling 3 Our approach: nonlinear implicit PIC Enforcing nonlinear convergence; complete consistency between particles, moments, and fields. Allowing stable and robust integrations with large t and x (2nd order accurate). Ensuring exact global energy conservation and local charge conservation properties. Allowing adaptivity in both time and space without loss of the conservation properties. Allowing particle subcycling high operational intensities (compute bound). Allowing fluid preconditioning to accelerate the iterative kinetic solver! 1 Mason, R. J. (1981), Brackbill, J. U., and Forslund, D. W. (1982) 2 Friedman, A., Langdon, A. B. and Cohen, B. I.(1981) 3 Cohen, B. I., Langdon, A. B., Hewett, D. W., and Procassini, R. J. (1989)

8 Fully implicit PIC: 1D electrostatic PIC Chen et al, JCP 211, 212, 213; Taitano et al, SISC (213)

9 Fully implicit PIC formulation (at first glance) A fully implicit formulation couples particles and fields non-trivially (integro-differential PDE): f n+1 f n t + v f n+1 + f n 2 2 Φ n+1 = q m Φn+1 + Φ n dv f n+1 or 2Φn+1 Φ n 2 t v f n+1 + f n 2 = = dv v f n+1 + f n 2 In PIC, f n+1 is sampled by a large collection of particles in phase space, {x, v} n+1 p. There are N p particles, each particle requiring 2 d equations (d dimensions), Field requires N g equations, one per grid point. If implemented naively, an impractically large algebraic system of equations results: G({x, v} n+1 p, {Φ n+1 } g ) = dim(g) = 2dN p + N g No current computing mainframe can afford the memory requirements Algorithmic issues are showstoppers (e.g., how to precondition it?) An alternative strategy exists: nonlinear elimination (particle enslavement)

10 Particle enslavement (nonlinear elimination) Full residual G({x, v} p, {Φ} g ) = is impractical to implement Alternative: nonlinearly eliminate particle quantities so that they are not dependent variables: Formally, particle equations of motion are functionals of the electrostatic potential: x n+1 p = x p [Φ n+1 ] ; v n+1 p = v p [Φ n+1 ] G(x p n+1, v p n+1, Φ n+1 ) = G(x[Φ n+1 ], v[φ n+1 ], Φ n+1 ) = G(Φ n+1 ) Nonlinear residual can be unambiguously formulated in terms of electrostatic potential only! JFNK storage requirements are dramatically decreased, making it tractable: Nonlinear solver storage requirements N g, comparable to a fluid simulation Particle quantities auxiliary variables: only a single copy of particle population needs to be maintained in memory throughout the nonlinear iteration

11 Energy-conserving (EC) Vlasov-Ampère discretization Fully implicit Crank-Nicolson time discretization: v n+1 p t v n p E n+1 i Ei n ε t x n+1 p t + j n+ 1/2 i j = ; x n p v n+ 1/2 p = ; q p m p E n+ 1/2 i S(x i x n+ 1/2 p )= ; i j n+ 1/2 i = q p v n+ 1/2 p S(x n+ 1/2 p x i ). p C-N enforces energy conservation to numerical round-off: p m p 2 (vn+1 p + v n p)(v n+1 p v n p) = i E n+1 i ε Ei n t E n+1 i + Ei n 2 p 1 2 m pv 2 1 p + 2 ε Ei 2 = const i No CFL condition. Does not suffer from finite-grid instabilities: x λ D!! Requires that particles and fields are nonlinearly converged.

12 Jacobian-Free Newton-Krylov Methods After spatial and temporal discretization a large set of nonlinear equations: G( x n+1 ) = Converging nonlinear couplings requires iteration: Newton-Raphson method: G δ x x k = G( xk ) k Jacobian linear systems result, which require a linear solver Krylov subspace methods (GMRES) Only require matrix-vector products to proceed. Jacobian-vector product can be computed Jacobian-free (CRITICAL: no need to form Jacobian matrix): ( ) G G( xk + ɛ y) G( xk ) y = J k y = lim x ɛ ɛ k Krylov methods can be easily preconditioned: P 1 k J 1 k J k P 1 k P k δ x = G k We will explore suitable preconditioning strategies later in this talk.

13 Algorithmic implementation details The nonlinear residual formulation G(E n+1 ) based on Vlasov-Ampere formulation is as follows: 1. Input E (given by JFNK iterative method) 2. Move particles (i.e., find x p [E], v p [E] by solving equations of motion) (a) Requires inner (local) nonlinear iteration: Picard (not stiff) (b) Can be as complicated as we desire (substepping, adaptivity, etc) 3. Compute moments (current) 4. Form Vlasov-Ampere equation residual 5. return Because dependent variables are fields, we can explore moment-based preconditioning! Because particle move is performed within function evaluation, we have much freedom. We can explore improvements in particle mover to ensure long-term accuracy! Particle substepping and orbit averaging (ensures orbit accuracy and preserves exact energy conservation) Exact charge conservation strategy (a new charge-conserving particle mover) Orbit adaptivity (to improve momentum conservation)

14 Adaptive, Charge conserving Particle orbit integration Multi-rate Integrator: field time-scale ( t) and orbit time-scale ( τ) can be well separated Field does not change appreciably in t. Accurate orbit integration requires particle sub-stepping! Particles stop at cell boundaries exact charge conservation for B-splines with order 2 ρ i+ 1 2 = p q p S m (x x i+ 1 2 ) x j i = p q p v p S m 1 (x x i ) x S m(x) = S m 1(x+ x 2 ) S m 1(x x x 2 ) (m=1,2) = [ t ρ + j = ] n+ 1 2 i+ 1 2 =

15 Energy conservation and orbit averaging Particle substepping breaks energy conservation. Energy conservation theorem can be recovered by orbit averaging Ampère s law: ɛ t E + j = j, 1 t+ t dτ[ ] t t ɛ E n+1 E n t + j = j Orbit-averaged current is found as: j = 1 t t+ t t dτ j 1 t p N ν q p v p S(x x p ) τ ν ν=1 With these definitions, exact energy conservation is recovered: p ν m p 2 (vν+1 p + v ν p)(v ν+1 p v ν E p) = n+1 E n ɛ t i E n+1 i + Ei n 2 p 1 2 m pv 2 1 p + 2 ɛ Ei 2 = const. i

16 K i K e Accuracy impact of adaptive charge-conserving im,sub-cn, t=1 movers 1e im,acc-cn, t=4 im,cn, t=.25 im,cn, t=1 a. b. (total energy) 4e-1-4e-1 c. total momentum Npx[(mvth)i+(mvth)e] 4e-4 2e-4-2e-4-4e-4 Ion acoustic oscillations im=implicit cn=crank-nicolson, sub=fixed-substepping acc=adaptive charge conserving t (x1) d.

17 Ion acoustic shock wave n i (a.u.) ex, dt=.1 im, dt= 1. im, dt=1. t = 3, 15, 23, 3..4 E (a.u.) x x x x Propagating IAW with perturbation level ɛ =.4, with 4 particles/cell. Realistic mass ratio (m i /m e = 2). Shock wave length scale Debye length.

18 Comparison against semi-implicit PIC

19 Moment-based acceleration of fully implicit kinetic solver Chen et al., JCP (214)

20 CPU gain potential of implicit PIC vs. explicit PIC Back-of-the-envelope estimate of CPU gain: CPU ( ) ( ) d T L n p C solver ; t x C imp C ex t imp N FE ; τ imp CPU ex CPU imp ( ximp x ex ) d τ imp t ex 1 N FE Using reasonable estimates: [ τ imp min.1 x ] imp, t imp v th t imp.1ω 1 pi t exp.1ω 1 pe k x imp.2 CPU ex 1 [ ] 1 1 mi min, CPU imp (kλ D ) d N FE kλ D m e x ex λ D CPU speedup is: Better for realistic mass ratios and increased dimensionality! Limited by solver performance N FE (preconditioning!) Largely independent of t for large enough time steps!

21 Moment-based acceleration of fully kinetic simulations Particle elimination nonlinear residual is formulated in terms of fields/moments ONLY: G(E) Within JFNK, preconditioner ONLY needs to provide field/moment update: δe P 1 G Premise of acceleration: obtain δe from a fluid model using current particle distribution for closure. We begin with corresponding fluid nonlinear model: t n α = Γ α m α [ t Γ α + ( 1 ] Γ α Γ α ) = q α n α E + n α ɛ t E = α q α Γ α ( n α ( Πα n α ) p )

22 Moment-based acceleration of fully kinetic simulations (cont.) We formulate approximate linearized fluid equations (neglect linear temperature response): δn α t m α δγ α t = δγ α q α (δn α E + n α,p δe) + ( Πα ) n α p δn α [ ] ɛ δe = t α q α δγ α G(E) δe can be obtained from Newton state E, Newton residual G(E), and particle closures Π α,p and n α,p

23 Preconditioner performance with t Number of FE GMRES: no prec w/ prec Newton: no prec w/ prec Average particle pushing time (s) 4 2 Pushing time: no prec w/ prec Total CPU: no prec w/ prec Total CPU time (s) ω pi t ω pi t Number of FE remains constant with t (preconditioning) Overall CPU time of algorithm is independent of t (as predicted!)

24 Preconditioner performance: CPU scaling CPU ex 1 [ ] 1 1 mi min, CPU imp (kλ D ) d N FE kλ D m e 1 1 prec no prec (kλ D ) -1. (kλ D ) CPU ex /CPU im kλ D Transition occurs at kλ D m e m i.25, as predicted

25 Electromagnetic PIC: non-radiative Darwin formulation Chen et al, CPC 214, 215

26 Light wave excitation and radiative noise in Vlasov-Maxwell If one keeps light wave with exact energy conservation, one gets enhanced numerical noise due to numerical Cherenkov radiation (or possibly instability). Noise-control requires numerical dissipation Figure 1: Fourier spectrum for Weibel instability. [Markidis and Lapenta, JCP 211]. Numerical dissipation breaks energy conservation Solution: analytically remove light-wave when relativistic effects are not important

27 Darwin model formulation (potential form) Darwin model is formal O(v/c) 2 approximation to Maxwell s equations 4 Analytically removes light-wave while preserving charge separation effects Begin with Maxwell s equations: Consider potentials φ, A such that: t B + E =, (1) 1 c 2 te + µ j = B, (2) E = ρ/ɛ, (3) B =. (4) (4) B = A, (1) E = φ t A. In the Coulomb gauge ( A = ), taking c in transverse displacement current: 4 Krause and Morrison (27) 1 (2) 2 A c 2 t 2 2 A = µ [j ɛ t φ], (2) ɛ 2 t φ = j.

28 Full Darwin system: Darwin model formulation (cont.) 1 µ 2 A = j ɛ t φ, (5) ɛ t 2 φ = j. (6) A = (7) 2 φ = ρ/ɛ (8) Enforcing involutions (Eqs. 7, 8) is critical for accuracy. Careful discretization allows one to imply involutions, rather than solving for them: A = implied by Eqs. 5, 6 and careful boundary conditions: 2 ( A) = 2 φ = ρ/ɛ implied by Eq. 6 and exact PIC charge conservation: t ρ + j = Minimal Darwin formulation (j obtained from particles): 2 χ = j, 2 A = µ [j χ], ɛ t φ = χ.

29 Numerical integration of Vlasov-Darwin in multi-d Work directly with potential formulation, avoiding explicit involutions Spatial discretization on a Yee mesh Automatic enforcement of Coulomb gauge ( A = ) and Gauss law ( 2 φ = ρ/ɛ ) NO divergence cleaning needed! Fully implicit, fully nonlinear time stepping (Crank-Nicolson) Particles are nonlinearly enslaved, subcycled, time-adapted (implicit Boris push) Exact local charge conservation (implies Gauss law) Exact global energy conservation Exact conservation of canonical momenta in ignorable directions E, A, j y y y B x B z B y Φ, ρ, E, A, j z z z E x, A x, j x

30 CPU speedup potential of EM implicit PIC vs. explicit PIC Back-of-the-envelope estimate of CPU gain: CPU ex CPU imp ( ximp x ex ) d τ imp t ex 1 N FE τ imp min t imp.1ω 1 pi t exp x exp c k x imp.2 x ex λ D CPU speedup is: [.1 x imp v th,e,.1ω 1 ce, t imp ] CPU ex 1 [ c 1 1 min, CPU imp (kλ D ) d v th,e N FE kλ D Impacted by electron-ion mass ratio, how close electrons are to relativistic speeds. Again, key is to minimize N FE. We have developed a very effective moment-based preconditioner. c v A ] me mi, m i m e

31 EM preconditioner summary 5 We have developed a fluid preconditioner that takes into account both ion and electron linear responses: Proper asymptotic behavior: Large domain sizes (L d i ): recover Hall MHD and MHD current responses Small electron-to-ion mass ratios, m e /m i 1 Effective for ω pe > ω ce, i.e., weakly to moderately magnetized plasmas m e m i > ( v Ac ) 2, i.e., it limits achievable mass ratio for fixed magnetic field Could be overcome with proper model for gyroviscous linear response If strongly magnetized regimes are of interest, then t imp.1ωce 1, and: CPU ex 1 c 1 CPU imp (kλ D ) d v th,e N FE Still strong potential for algorithmic acceleration. 5 Chen and LC, CPC (submitted)

32 Isotropic ions, bi-maxwellian electrons 1D Electron Weibel instability m i /m e = 1836, T e /T e = 16, N e,i =128,, L = 2πc/ω pe, N g =32. 2e-16 charge conservation 1e-16 CPU ex /CPU im 1 1 (kλ D ) kλ D 4e-11 energy conservation 2e-11-2e-11-4e-11 4e-6 momentum conservation (x) 2e-6-2e-6-4e-6 1e-12 5e-13-5e-13-1e-12 1e-12 5e-13-5e-13-1e-12 canonical momentum conservation (y) canonical momentum conservation (z) ω pe t

33 Impact of Multi-rate Integrator on Temporal Rate of Convergence Numerical demonstration of second-order accuracy in time Absolute error.1.1 1e-5 1e-6 1e-7 1e-8 t=28 t=32 t=36 t=4 average 1e ω pe t

34 2D Weibel instability m i /m e = 1836, T e /T e = 9, N pc =2, L = π d e π d e, N g = magnetic energy density e-5 1e-6 1e-7 1e-8 implicit explicit linear theory (γ max =.12) ω pe t 5e-15 1e-15 1e-6 1e-8 1e-1 1e-12 2e-8 charge conservation implicit explicit energy conservation momentum conservation (x) 1-2e-8 CPU ex /CPU im (kλ D ) -2 (kλ D ) -3 1e-8 1e-12 1e-16 1e-13 canonical momentum conservation (z) div(a) kλ D 1e ω pe t

35 2D Weibel instability in curvilinear mesh L x L y = 1 d e 1 d e, N g = 16 16, t =.1ω 1 pi magnetic energy density e-5 1e-6 1e-7 1e-8 uniform grid sin map,.5 sin map, ω pe t

36 2D Weibel instability in curvilinear mesh (cont.) charge conservation uniform grid curvilinear grid 2e-7 1e-7 1 energy conservation 2e-5-2e-5 5 momentum conservation (x) canonical momentum conservation (z) div(a) ω pe t 2e-7-2e-7 5e-9-5e-9 4e-7 2e Sin map ɛ =.15 tol = 6e-4. hybrid pusher (Wang et. al. JPP (1999)): position in logical space; velocity in physical space Grid metrics are cell based (i.e. NGP). Need more sophisticated interpolation.

37 2D Electron Weibel instability: preconditioner performance L x L y = (d 2 e), N pc = 2, t =.1ω 1 pi N x N y = no preconditioner with preconditioner m i /m e Newton GMRES Newton GMRES m i /m e = 1836 no preconditioner with preconditioner N x N y Newton GMRES Newton GMRES

38 2D KAW: impact of magnetization B x, =.667, v et /c =.745 (β e =.1), t =.1ω 1 pi L x L y = 1 1(d 2 i ) N pc = 5 N x N y = m i /m e = 25 L x L y = 22 22(d 2 i ) N pc = 2, N x N y = Fixed magnetic field magnetic energy density m i /m e no preconditioner with preconditioner Newton GMRES Newton GMRES ω pe /ω ce = 3 1e-5 implicit simulation linear theory (γ max =.225) ω ci t m i /m e no preconditioner with preconditioner Newton GMRES Newton GMRES NC NC 4 5.9

39 Summary and conclusions We have demonstrated a fully implicit, fully nonlinear, multidimensional PIC formulation that features: Exact local charge conservation (via a novel particle mover strategy). Exact global energy conservation (no particle self-heating or self-cooling). Adaptive particle orbit integrator to control errors in momentum conservation. Canonical momenta (EM-PIC only, reduced dimensionality). The approach is free of numerical instabilities: ω pe t 1, and x λ D Requires many fewer dofs (vs. explicit PIC) for comparable accuracy in challenging problems Significant CPU gains (vs explicit PIC) have been demonstrated The method has much potential for efficiency gains vs. explicit in long-time-scale applications: CPU ex 1 c CPU imp (kλ D ) d v }{{ th,e } Physics Precond. {}}{ 1 N FE. Moment-based acceleration is effective in minimizing N FE, leading to an optimal algorithm.

Guangye Chen, Luis Chacón,

Guangye Chen, Luis Chacón, JIFT workshop! Oct. 31, 2014 New Orleans, LA.! Guangye Chen, Luis Chacón, CoCoMANs team Los Alamos National Laboratory, Los Alamos, NM 87545, USA gchen@lanl.gov 1 Los Alamos National Laboratory Motivation

More information

Hybrid Simulations: Numerical Details and Current Applications

Hybrid Simulations: Numerical Details and Current Applications Hybrid Simulations: Numerical Details and Current Applications Dietmar Krauss-Varban and numerous collaborators Space Sciences Laboratory, UC Berkeley, USA Boulder, 07/25/2008 Content 1. Heliospheric/Space

More information

Chapter 1. Introduction to Nonlinear Space Plasma Physics

Chapter 1. Introduction to Nonlinear Space Plasma Physics Chapter 1. Introduction to Nonlinear Space Plasma Physics The goal of this course, Nonlinear Space Plasma Physics, is to explore the formation, evolution, propagation, and characteristics of the large

More information

Multigrid solvers for equations arising in implicit MHD simulations

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

More information

Plasma waves in the fluid picture I

Plasma waves in the fluid picture I Plasma waves in the fluid picture I Langmuir oscillations and waves Ion-acoustic waves Debye length Ordinary electromagnetic waves General wave equation General dispersion equation Dielectric response

More information

Lecture 4: The particle equations (1)

Lecture 4: The particle equations (1) Lecture 4: The particle equations (1) Presenter: Mark Eric Dieckmann Department of Science and Technology (ITN), Linköping University, Sweden July 17, 2014 Overview We have previously discussed the leapfrog

More information

arxiv: v1 [physics.comp-ph] 9 Aug 2011

arxiv: v1 [physics.comp-ph] 9 Aug 2011 The Energy Conserving Particle-in-Cell Method arxiv:1108.1959v1 [physics.comp-ph] 9 Aug 2011 Stefano Markidis and Giovanni Lapenta Centre for Plasma Astrophysics, Katholieke Universiteit Leuven, Celestijnenlaan

More information

Parsek2D: An Implicit Parallel Particle-in-Cell Code

Parsek2D: An Implicit Parallel Particle-in-Cell Code NUMERICAL MODELING OF SPACE PLASMA FLOWS: ASTRONUM-2008 ASP Conference Series, Vol. 406, c 2009 Nikolai V. Pogorelov, Edouard Audit, Phillip Colella, and Gary P. Zank, eds. Parsek2D: An Implicit Parallel

More information

Outline. 1 Why PIC Simulations Make Sense. 2 The Algorithm. 3 Examples Surface High Harmonics Generation. 4 Extensions Of The PIC Algorithm

Outline. 1 Why PIC Simulations Make Sense. 2 The Algorithm. 3 Examples Surface High Harmonics Generation. 4 Extensions Of The PIC Algorithm PIC Simulations an Introduction GRK 1203 Meeting February 12-15, 2008, Oelde Outline 1 Simulations Make Sense 2 3 Surface High Harmonics Generation 4 Of PIC Plasma Physics Is Complex Experiment real thing

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

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

New Streamfunction Approach for Magnetohydrodynamics

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

More information

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

Waves in plasma. Denis Gialis

Waves in plasma. Denis Gialis Waves in plasma Denis Gialis This is a short introduction on waves in a non-relativistic plasma. We will consider a plasma of electrons and protons which is fully ionized, nonrelativistic and homogeneous.

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 Comparison between the Two-fluid Plasma Model and Hall-MHD for Captured Physics and Computational Effort 1

A Comparison between the Two-fluid Plasma Model and Hall-MHD for Captured Physics and Computational Effort 1 A Comparison between the Two-fluid Plasma Model and Hall-MHD for Captured Physics and Computational Effort 1 B. Srinivasan 2, U. Shumlak Aerospace and Energetics Research Program University of Washington,

More information

Applying Asymptotic Approximations to the Full Two-Fluid Plasma System to Study Reduced Fluid Models

Applying Asymptotic Approximations to the Full Two-Fluid Plasma System to Study Reduced Fluid Models 0-0 Applying Asymptotic Approximations to the Full Two-Fluid Plasma System to Study Reduced Fluid Models B. Srinivasan, U. Shumlak Aerospace and Energetics Research Program, University of Washington, Seattle,

More information

Kinetic Plasma Simulations in Astrophysics. Lorenzo Sironi

Kinetic Plasma Simulations in Astrophysics. Lorenzo Sironi Kinetic Plasma Simulations in Astrophysics Lorenzo Sironi Outline Plasma physics in astrophysics. The Vlasov-Maxwell system. Fully-kinetic particle-in-cell codes. 1. Electrostatic codes. 2. Electromagnetic

More information

Macroscopic plasma description

Macroscopic plasma description Macroscopic plasma description Macroscopic plasma theories are fluid theories at different levels single fluid (magnetohydrodynamics MHD) two-fluid (multifluid, separate equations for electron and ion

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

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

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

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

Concurrent Divide-and-Conquer Library

Concurrent Divide-and-Conquer Library with Petascale Electromagnetics Applications, Tech-X Corporation CScADS Workshop on Libraries and Algorithms for Petascale Applications, 07/30/2007, Snowbird, Utah Background Particle In Cell (PIC) in

More information

Ideal Magnetohydrodynamics (MHD)

Ideal Magnetohydrodynamics (MHD) Ideal Magnetohydrodynamics (MHD) Nick Murphy Harvard-Smithsonian Center for Astrophysics Astronomy 253: Plasma Astrophysics February 1, 2016 These lecture notes are largely based on Lectures in Magnetohydrodynamics

More information

Particle-in-cell (PIC) simulation output for the temporal evolution of magnetic fields.

Particle-in-cell (PIC) simulation output for the temporal evolution of magnetic fields. Type of file: pdf Title of file for HTML: Supplementary Information Description: Supplementary Figures and Supplementary Discussion. Type of file: MOV Title of file for HTML: Supplementary Movie 1 Description:

More information

High-Fidelity RF Gun Simulations with the Parallel 3D Finite Element Particle-In-Cell Code Pic3P

High-Fidelity RF Gun Simulations with the Parallel 3D Finite Element Particle-In-Cell Code Pic3P High-Fidelity RF Gun Simulations with the Parallel D Finite Element Particle-In-Cell Code PicP SLAC-PUB-668 June 9 A. Candel, A. Kabel, L. Lee, Z. Li, C. Limborg, C. Ng, G. Schussman and K. Ko SLAC National

More information

Particle-in-Cell Codes for plasma-based particle acceleration

Particle-in-Cell Codes for plasma-based particle acceleration A. Pukhov Institute for Theoretical Physics I University of Dusseldorf, Germany Particle-in-Cell Codes for plasma-based particle acceleration Outline Relativistic plasmas, acceleration and the simulation

More information

School and Conference on Analytical and Computational Astrophysics November, 2011

School and Conference on Analytical and Computational Astrophysics November, 2011 2292-22 School and Conference on Analytical and Computational Astrophysics 14-25 November, 2011 Multiscale and Multiphysics Challenge in Modeling of Space Weather - 2 Giovanni Lapenta Katholic University

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

Simulation Techniques for HED I: Particle-in-Cell Methods

Simulation Techniques for HED I: Particle-in-Cell Methods 2015 HED Summer School Simulation Techniques for HED I: Particle-in-Cell Methods Frank S. Tsung UCLA Special Thanks Viktor Decyk Peicheng Yu < - Slides Michael Meyers Thamine Dalichaouch < - Demos Outline

More information

Forced hybrid-kinetic turbulence in 2D3V

Forced hybrid-kinetic turbulence in 2D3V Forced hybrid-kinetic turbulence in 2D3V Silvio Sergio Cerri1,2 1 In collaboration with: 3 F. Califano, F. Rincon, F. Jenko4, D. Told4 1 Physics Department E. Fermi, University of Pisa, Italy fu r Plasmaphysik,

More information

PIC Simulation of Magnetic Reconnection with Adaptive Mesh Refinement

PIC Simulation of Magnetic Reconnection with Adaptive Mesh Refinement PIC Simulation of Magnetic Reconnection with Adaptive Mesh Refinement Keizo Fujimoto National Astronomical Observatory of Japan Overview Introduction Particle-in-Cell (PIC) model with adaptive mesh refinement

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

Implicit-Explicit Time Integration of a High-Order Particle-in-Cell Method with Hyperbolic Divergence Cleaning.

Implicit-Explicit Time Integration of a High-Order Particle-in-Cell Method with Hyperbolic Divergence Cleaning. Implicit-Explicit Time Integration of a High-Order Particle-in-Cell Method with Hyperbolic Divergence Cleaning. G.B. Jacobs a J.S. Hesthaven b a Department of Aerospace Engineering & Engineering Mechanics,

More information

Fluid equations, magnetohydrodynamics

Fluid equations, magnetohydrodynamics Fluid equations, magnetohydrodynamics Multi-fluid theory Equation of state Single-fluid theory Generalised Ohm s law Magnetic tension and plasma beta Stationarity and equilibria Validity of magnetohydrodynamics

More information

High-order energy conserving, (discontinuous) finite-element algorithms for (gyro) kinetic simulations of plasmas

High-order energy conserving, (discontinuous) finite-element algorithms for (gyro) kinetic simulations of plasmas High-order energy conserving, (discontinuous) finite-element algorithms for (gyro) kinetic simulations of plasmas Ammar H. Hakim 1 G. Hammett 1 E. Shi 1,2 1 Princeton Plasma Physics Laboratory, Princeton,

More information

Simulation of Plasma Wakefields and Weibel Instability of Electron Beams in Plasma Using Codes LSP and OSIRIS

Simulation of Plasma Wakefields and Weibel Instability of Electron Beams in Plasma Using Codes LSP and OSIRIS Simulation of Plasma Wakefields and Weibel Instability of Electron Beams in Plasma Using Codes and OSIRIS 15 Electron density Beam density Plasma density 4 6 4 A. Solodov, C. Ren, J. Myatt, and R. Betti

More information

Hybrid Kinetic-MHD simulations with NIMROD

Hybrid Kinetic-MHD simulations with NIMROD simulations with NIMROD Charlson C. Kim and the NIMROD Team Plasma Science and Innovation Center University of Washington CSCADS Workshop July 18, 2011 NIMROD C.R. Sovinec, JCP, 195, 2004 parallel, 3-D,

More information

PHYSICS OF HOT DENSE PLASMAS

PHYSICS OF HOT DENSE PLASMAS Chapter 6 PHYSICS OF HOT DENSE PLASMAS 10 26 10 24 Solar Center Electron density (e/cm 3 ) 10 22 10 20 10 18 10 16 10 14 10 12 High pressure arcs Chromosphere Discharge plasmas Solar interior Nd (nω) laserproduced

More information

2/8/16 Dispersive Media, Lecture 5 - Thomas Johnson 1. Waves in plasmas. T. Johnson

2/8/16 Dispersive Media, Lecture 5 - Thomas Johnson 1. Waves in plasmas. T. Johnson 2/8/16 Dispersive Media, Lecture 5 - Thomas Johnson 1 Waves in plasmas T. Johnson Introduction to plasma physics Magneto-Hydro Dynamics, MHD Plasmas without magnetic fields Cold plasmas Transverse waves

More information

Fundamentals of wave kinetic theory

Fundamentals of wave kinetic theory Fundamentals of wave kinetic theory Introduction to the subject Perturbation theory of electrostatic fluctuations Landau damping - mathematics Physics of Landau damping Unmagnetized plasma waves The plasma

More information

arxiv: v2 [physics.comp-ph] 7 Jan 2008

arxiv: v2 [physics.comp-ph] 7 Jan 2008 arxiv:0707.111v [physics.comp-ph] 7 Jan 008 Abstract An iterative semi-implicit scheme with robust damping N. F. Loureiro a,b, G. W. Hammett b a CMPD, University of Maryland, College Park, MD 074, USA

More information

AMSC 663 Project Proposal: Upgrade to the GSP Gyrokinetic Code

AMSC 663 Project Proposal: Upgrade to the GSP Gyrokinetic Code AMSC 663 Project Proposal: Upgrade to the GSP Gyrokinetic Code George Wilkie (gwilkie@umd.edu) Supervisor: William Dorland (bdorland@umd.edu) October 11, 2011 Abstract Simulations of turbulent plasma in

More information

Dispersive Media, Lecture 7 - Thomas Johnson 1. Waves in plasmas. T. Johnson

Dispersive Media, Lecture 7 - Thomas Johnson 1. Waves in plasmas. T. Johnson 2017-02-14 Dispersive Media, Lecture 7 - Thomas Johnson 1 Waves in plasmas T. Johnson Introduction to plasmas as a coupled system Magneto-Hydro Dynamics, MHD Plasmas without magnetic fields Cold plasmas

More information

Accurate representation of velocity space using truncated Hermite expansions.

Accurate representation of velocity space using truncated Hermite expansions. Accurate representation of velocity space using truncated Hermite expansions. Joseph Parker Oxford Centre for Collaborative Applied Mathematics Mathematical Institute, University of Oxford Wolfgang Pauli

More information

Space Plasma Physics Thomas Wiegelmann, 2012

Space Plasma Physics Thomas Wiegelmann, 2012 Space Plasma Physics Thomas Wiegelmann, 2012 1. Basic Plasma Physics concepts 2. Overview about solar system plasmas Plasma Models 3. Single particle motion, Test particle model 4. Statistic description

More information

Plasma Astrophysics Chapter 1: Basic Concepts of Plasma. Yosuke Mizuno Institute of Astronomy National Tsing-Hua University

Plasma Astrophysics Chapter 1: Basic Concepts of Plasma. Yosuke Mizuno Institute of Astronomy National Tsing-Hua University Plasma Astrophysics Chapter 1: Basic Concepts of Plasma Yosuke Mizuno Institute of Astronomy National Tsing-Hua University What is a Plasma? A plasma is a quasi-neutral gas consisting of positive and negative

More information

sri 2D Implicit Charge- and Energy- Conserving Particle-in-cell Application Using CUDA Christopher Leibs Karthik Murthy

sri 2D Implicit Charge- and Energy- Conserving Particle-in-cell Application Using CUDA Christopher Leibs Karthik Murthy 2D Implicit Charge- and Energy- Conserving sri Particle-in-cell Application Using CUDA Christopher Leibs Karthik Murthy Mentors Dana Knoll and Allen McPherson IS&T CoDesign Summer School 2012, Los Alamos

More information

Particle in Cell method

Particle in Cell method Particle in Cell method Birdsall and Langdon: Plasma Physics via Computer Simulation Dawson: Particle simulation of plasmas Hockney and Eastwood: Computer Simulations using Particles we start with an electrostatic

More information

Energy Stable Discontinuous Galerkin Methods for Maxwell s Equations in Nonlinear Optical Media

Energy Stable Discontinuous Galerkin Methods for Maxwell s Equations in Nonlinear Optical Media Energy Stable Discontinuous Galerkin Methods for Maxwell s Equations in Nonlinear Optical Media Yingda Cheng Michigan State University Computational Aspects of Time Dependent Electromagnetic Wave Problems

More information

Some notes about PDEs. -Bill Green Nov. 2015

Some notes about PDEs. -Bill Green Nov. 2015 Some notes about PDEs -Bill Green Nov. 2015 Partial differential equations (PDEs) are all BVPs, with the same issues about specifying boundary conditions etc. Because they are multi-dimensional, they can

More information

Solution of time-dependent Boltzmann equation for electrons in non-thermal plasma

Solution of time-dependent Boltzmann equation for electrons in non-thermal plasma Solution of time-dependent Boltzmann equation for electrons in non-thermal plasma Z. Bonaventura, D. Trunec Department of Physical Electronics Faculty of Science Masaryk University Kotlářská 2, Brno, CZ-61137,

More information

Parallel transport and profile of boundary plasma with a low recycling wall

Parallel transport and profile of boundary plasma with a low recycling wall 1 TH/P4-16 Parallel transport and profile of boundary plasma with a low recycling wall Xian-Zhu Tang 1 and Zehua Guo 1 1 Theoretical Division, Los Alamos National Laboratory, Los Alamos, NM 87545, U.S.A.

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

Gyrokinetics an efficient framework for studying turbulence and reconnection in magnetized plasmas

Gyrokinetics an efficient framework for studying turbulence and reconnection in magnetized plasmas Frank Jenko Gyrokinetics an efficient framework for studying turbulence and reconnection in magnetized plasmas Max-Planck-Institut für Plasmaphysik, Garching Workshop on Vlasov-Maxwell Kinetics WPI, Vienna,

More information

26. Non-linear effects in plasma

26. Non-linear effects in plasma Phys780: Plasma Physics Lecture 26. Non-linear effects. Collisionless shocks.. 1 26. Non-linear effects in plasma Collisionless shocks ([1], p.405-421, [6], p.237-245, 249-254; [4], p.429-440) Collisionless

More information

AST 553. Plasma Waves and Instabilities. Course Outline. (Dated: December 4, 2018)

AST 553. Plasma Waves and Instabilities. Course Outline. (Dated: December 4, 2018) AST 553. Plasma Waves and Instabilities Course Outline (Dated: December 4, 2018) I. INTRODUCTION Basic concepts Waves in plasmas as EM field oscillations Maxwell s equations, Gauss s laws as initial conditions

More information

Implicit Solution of Viscous Aerodynamic Flows using the Discontinuous Galerkin Method

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

More information

Tight-Focusing of Short Intense Laser Pulses in Particle-in-Cell Simulations of Laser-Plasma Interaction

Tight-Focusing of Short Intense Laser Pulses in Particle-in-Cell Simulations of Laser-Plasma Interaction 16/05/2017, CTU in Prague Tight-Focusing of Short Intense Laser Pulses in Particle-in-Cell Simulations of Laser-Plasma Interaction Bc. Petr Valenta (petr.valenta@eli-beams.eu) Supervisors: doc. Ing. Ondrej

More information

An asymptotic preserving unified gas kinetic scheme for the grey radiative transfer equations

An asymptotic preserving unified gas kinetic scheme for the grey radiative transfer equations An asymptotic preserving unified gas kinetic scheme for the grey radiative transfer equations Institute of Applied Physics and Computational Mathematics, Beijing NUS, Singapore, March 2-6, 2015 (joint

More information

GTC Simulation of Turbulence and Transport in Tokamak Plasmas

GTC Simulation of Turbulence and Transport in Tokamak Plasmas GTC Simulation of Turbulence and Transport in Tokamak Plasmas Z. Lin University it of California, i Irvine, CA 92697, USA and GPS-TTBP Team Supported by SciDAC GPS-TTBP, GSEP & CPES Motivation First-principles

More information

The importance of including XMHD physics in HED codes

The importance of including XMHD physics in HED codes The importance of including XMHD physics in HED codes Charles E. Seyler, Laboratory of Plasma Studies, School of Electrical and Computer Engineering, Cornell University Collaborators: Nat Hamlin (Cornell)

More information

First-Order Systems Least-Squares Finite Element Methods and Nested Iteration for Electromagnetic Two-Fluid Kinetic-Based Plasma Models

First-Order Systems Least-Squares Finite Element Methods and Nested Iteration for Electromagnetic Two-Fluid Kinetic-Based Plasma Models University of Colorado, Boulder CU Scholar Applied Mathematics Graduate Theses & Dissertations Applied Mathematics Spring 1-1-2014 First-Order Systems Least-Squares Finite Element Methods and Nested Iteration

More information

Newton s Method and Efficient, Robust Variants

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

More information

Linear Solvers. Andrew Hazel

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

More information

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

Simulation of Relativistic Jet-Plasma Interactions

Simulation of Relativistic Jet-Plasma Interactions Simulation of Relativistic Jet-Plasma Interactions Robert Noble and Johnny Ng Stanford Linear Accelerator Center SABER Workshop, Laboratory Astrophysics WG SLAC, March 15-16, 2006 Motivations High energy

More information

Moving Weakly Relativistic Electromagnetic Solitons in Laser-Plasmas

Moving Weakly Relativistic Electromagnetic Solitons in Laser-Plasmas Moving Weakly Relativistic Electromagnetic Solitons in Laser-Plasmas Lj. Hadžievski, A. Mančić and M.M. Škorić Department of Physics, Faculty of Sciences and Mathematics, University of Niš, P.O. Box 4,

More information

An Efficient Low Memory Implicit DG Algorithm for Time Dependent Problems

An Efficient Low Memory Implicit DG Algorithm for Time Dependent Problems An Efficient Low Memory Implicit DG Algorithm for Time Dependent Problems P.-O. Persson and J. Peraire Massachusetts Institute of Technology 2006 AIAA Aerospace Sciences Meeting, Reno, Nevada January 9,

More information

Two-scale numerical solution of the electromagnetic two-fluid plasma-maxwell equations: Shock and soliton simulation

Two-scale numerical solution of the electromagnetic two-fluid plasma-maxwell equations: Shock and soliton simulation Mathematics and Computers in Simulation 76 (2007) 3 7 Two-scale numerical solution of the electromagnetic two-fluid plasma-maxwell equations: Shock and soliton simulation S. Baboolal a,, R. Bharuthram

More information

Multiscale, multiphysics modeling of turbulent transport and heating in collisionless, magnetized plasmas

Multiscale, multiphysics modeling of turbulent transport and heating in collisionless, magnetized plasmas Multiscale, multiphysics modeling of turbulent transport and heating in collisionless, magnetized plasmas Michael Barnes Plasma Science & Fusion Center Massachusetts Institute of Technology Collaborators:

More information

Kinetic relaxation models for reacting gas mixtures

Kinetic relaxation models for reacting gas mixtures Kinetic relaxation models for reacting gas mixtures M. Groppi Department of Mathematics and Computer Science University of Parma - ITALY Main collaborators: Giampiero Spiga, Giuseppe Stracquadanio, Univ.

More information

Preconditioning the Newton-Krylov method for reactive transport

Preconditioning the Newton-Krylov method for reactive transport Preconditioning the Newton-Krylov method for reactive transport Michel Kern, L. Amir, A. Taakili INRIA Paris-Rocquencourt Maison de la Simulation MoMaS workshop Reactive Transport Modeling in the Geological

More information

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

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

More information

Z. Lin University of California, Irvine, CA 92697, USA. Supported by SciDAC GPS-TTBP, GSEP & CPES

Z. Lin University of California, Irvine, CA 92697, USA. Supported by SciDAC GPS-TTBP, GSEP & CPES GTC Framework Development and Application Z. Lin University of California, Irvine, CA 92697, USA and dgpsttbp GPS-TTBP Team Supported by SciDAC GPS-TTBP, GSEP & CPES GPS-TTBP Workshop on GTC Framework

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

Indefinite and physics-based preconditioning

Indefinite and physics-based preconditioning Indefinite and physics-based preconditioning Jed Brown VAW, ETH Zürich 2009-01-29 Newton iteration Standard form of a nonlinear system F (u) 0 Iteration Solve: Update: J(ũ)u F (ũ) ũ + ũ + u Example (p-bratu)

More information

Tight-Focusing of Short Intense Laser Beams in Particle-in-Cell Simulations of Laser-Plasma Interaction

Tight-Focusing of Short Intense Laser Beams in Particle-in-Cell Simulations of Laser-Plasma Interaction 28/03/2017, CTU in Prague Tight-Focusing of Short Intense Laser Beams in Particle-in-Cell Simulations of Laser-Plasma Interaction Bc. Petr Valenta (petr.valenta@eli-beams.eu) Supervisors: doc. Ing. Ondrej

More information

Kinetic, Fluid & MHD Theories

Kinetic, Fluid & MHD Theories Lecture 2 Kinetic, Fluid & MHD Theories The Vlasov equations are introduced as a starting point for both kinetic theory and fluid theory in a plasma. The equations of fluid theory are derived by taking

More information

Study of Laser Plasma Interactions Using an Eulerian Vlasov Code

Study of Laser Plasma Interactions Using an Eulerian Vlasov Code PSFC/JA-04-6 Study of Laser Plasma Interactions Using an Eulerian Vlasov Code D. J. Strozzi, M. M. Shoucri*, and A. Bers March 2004 Plasma Science and Fusion Center Massachusetts Institute of Technology

More information

Kinetic damping in gyro-kinetic simulation and the role in multi-scale turbulence

Kinetic damping in gyro-kinetic simulation and the role in multi-scale turbulence 2013 US-Japan JIFT workshop on New Aspects of Plasmas Kinetic Simulation NIFS, November 22-23, 2013 Kinetic damping in gyro-kinetic simulation and the role in multi-scale turbulence cf. Revisit for Landau

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

Verification and Convergence Properties of a Particle-In-Cell Code

Verification and Convergence Properties of a Particle-In-Cell Code Verification and Convergence Properties of a Particle-In-Cell Code B. J. Winjum 1, J. J. Tu 2, S. S. Su 3, V. K. Decyk 1, W. B. Mori 1 1 UCLA 2 Fudan U., China 3 U. Michigan 2014 Anomalous Absorption Conference

More information

NIMEQ: MHD Equilibrium Solver for NIMROD

NIMEQ: MHD Equilibrium Solver for NIMROD NIMEQ: MHD Equilibrium Solver for NIMOD E.C.Howell, C..Sovinec University of Wisconsin-Madison 5 th Annual Meeting of Division of Plasma Physics Dallas, Texas, Nov. 17-Nov. 1,8 1 Abstract A Grad-Shafranov

More information

This article appeared in a journal published by Elsevier. The attached copy is furnished to the author for internal non-commercial research and

This article appeared in a journal published by Elsevier. The attached copy is furnished to the author for internal non-commercial research and This article appeared in a journal published by Elsevier. The attached copy is furnished to the author for internal non-commercial research and education use, including for instruction at the authors institution

More information

Monte Carlo Collisions in Particle in Cell simulations

Monte Carlo Collisions in Particle in Cell simulations Monte Carlo Collisions in Particle in Cell simulations Konstantin Matyash, Ralf Schneider HGF-Junior research group COMAS : Study of effects on materials in contact with plasma, either with fusion or low-temperature

More information

PIC Algorithm with Multiple Poisson Equation Solves During One Time Step

PIC Algorithm with Multiple Poisson Equation Solves During One Time Step Journal of Physics: Conference Series PAPER OPEN ACCESS PIC Algorithm with Multiple Poisson Equation Solves During One Time Step To cite this article: Junxue Ren et al 2015 J. Phys.: Conf. Ser. 640 012033

More information

Equation Free Projective Integration and its Applicability for Simulating Plasma Results: 1D Ion Acoustic Wave. Michael Shay University of Maryland

Equation Free Projective Integration and its Applicability for Simulating Plasma Results: 1D Ion Acoustic Wave. Michael Shay University of Maryland Equation Free Projective Integration and its Applicability for Simulating Plasma Results: 1D Ion Acoustic Wave Michael Shay University of Maryland Collaborators Center for Multiscale Plasma Dynamics Jim

More information

Finite Element Solver for Flux-Source Equations

Finite Element Solver for Flux-Source Equations Finite Element Solver for Flux-Source Equations Weston B. Lowrie A thesis submitted in partial fulfillment of the requirements for the degree of Master of Science in Aeronautics Astronautics University

More information

Gyrokinetic simulations with GYSELA: Main current issues in physics & numerics

Gyrokinetic simulations with GYSELA: Main current issues in physics & numerics Gyrokinetic simulations with GYSELA: Main current issues in physics & numerics Y. Sarazin, Y. Asahi 2, N. Bouzat, G. Dif-Pradalier, P. Donnel, C. Ehrlacher, C. Emeriau 3, X. Garbet, Ph. Ghendrih, V. Grandgirard,

More information

Electromagnetic Turbulence Simulations with Kinetic Electrons from the the Summit Framework

Electromagnetic Turbulence Simulations with Kinetic Electrons from the the Summit Framework 19th IAEA Fusion Energy Conference Tuesday, October 15, 2002 Paper: TH/P1-13 Electromagnetic Turbulence Simulations with Kinetic Electrons from the the Summit Framework Scott Parker and Yang Chen University

More information

Method of Perturbative-PIC Simulation for CSR Effect

Method of Perturbative-PIC Simulation for CSR Effect Method of Perturbative-PIC Simulation for CSR Effect Jack J. Shi Department of Physics & Astronomy, University of Kansas OUTLINE Why Do We Want to Do This? Perturbation Expansion of the Retardation of

More information

Linear and non-linear evolution of the gyroresonance instability in Cosmic Rays

Linear and non-linear evolution of the gyroresonance instability in Cosmic Rays Linear and non-linear evolution of the gyroresonance instability in Cosmic Rays DESY Summer Student Programme, 2016 Olga Lebiga Taras Shevchenko National University of Kyiv, Ukraine Supervisors Reinaldo

More information

arxiv:gr-qc/ v2 6 Apr 1999

arxiv:gr-qc/ v2 6 Apr 1999 1 Notations I am using the same notations as in [3] and [2]. 2 Temporal gauge - various approaches arxiv:gr-qc/9801081v2 6 Apr 1999 Obviously the temporal gauge q i = a i = const or in QED: A 0 = a R (1)

More information

Hybrid Kinetic-MHD simulations with NIMROD

Hybrid Kinetic-MHD simulations with NIMROD in NIMROD simulations with NIMROD Charlson C. Kim 1 Dylan P. Brennan 2 Yasushi Todo 3 and the NIMROD Team 1 University of Washington, Seattle 2 University of Tulsa 3 NIFS, Toki-Japan December 2&3, 2011

More information

TAU Solver Improvement [Implicit methods]

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

More information

FVM for Fluid-Structure Interaction with Large Structural Displacements

FVM for Fluid-Structure Interaction with Large Structural Displacements FVM for Fluid-Structure Interaction with Large Structural Displacements Željko Tuković and Hrvoje Jasak Zeljko.Tukovic@fsb.hr, h.jasak@wikki.co.uk Faculty of Mechanical Engineering and Naval Architecture

More information

Two-level Domain decomposition preconditioning for the high-frequency time-harmonic Maxwell equations

Two-level Domain decomposition preconditioning for the high-frequency time-harmonic Maxwell equations Two-level Domain decomposition preconditioning for the high-frequency time-harmonic Maxwell equations Marcella Bonazzoli 2, Victorita Dolean 1,4, Ivan G. Graham 3, Euan A. Spence 3, Pierre-Henri Tournier

More information

Algebraic Multigrid as Solvers and as Preconditioner

Algebraic Multigrid as Solvers and as Preconditioner Ò Algebraic Multigrid as Solvers and as Preconditioner Domenico Lahaye domenico.lahaye@cs.kuleuven.ac.be http://www.cs.kuleuven.ac.be/ domenico/ Department of Computer Science Katholieke Universiteit Leuven

More information