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

Size: px
Start display at page:

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

Transcription

1 2015 HED Summer School Simulation Techniques for HED I: Particle-in-Cell Methods Frank S. Tsung UCLA

2 Special Thanks Viktor Decyk Peicheng Yu < - Slides Michael Meyers Thamine Dalichaouch < - Demos

3 Outline What is PIC? Some examples of large PIC simulations (HED and non-hed) and what are systems which are appropriate for PIC simulations? Various parts of the PIC code, how is each part implemented, show you the limitations of the numerical methods and show you how to design good simulations based on these limitations. Interpolation Particle Orbit Calculation Field Calculation Numerical Cherenkov Radiation - How do we mitigate it so we can study relativistic shocks, and study LWFA s in Lorentz boosted frames

4 Examples of PIC simulations outside of HED PIC models are used in many areas of plasma physics. One area where PIC models have made a large impact is magnetized fusion, and I will show you an example of a large fusion simulation. Gyrokinetic Simulation of Ion Temperature Gradient (ITG) Instability PIC codes are used in space plasmas, nonneutral plasmas, etc.. In this lecture, I will be presenting the PIC models that are used most in the study of HED plasmas and introduce some basic concepts in numerical analysis

5 Examples of PIC simulations in HED Plasmas Electron Plasma Waves in 3D (BEPS simulation relevant to IFE) Laser Solid Interactions in 3D (Ion Accelerations via Fermi Acceleration) Plasma Based Accelerators (Ion Accelerations)

6 References C. K. Birdsall and A. Bruce Langdon, Plasma Physics via Computer Simulation [McGraw-Hill, New York, 1985]. J. M. Dawson, Review of Modern Physics, 55, 403 (1983). R. W. Hockney and J. W. Eastwood, Computer Simulation Using Particles [McGraw- Hill, New York, 1981]. W. H. Press, B. P. Flannery, S. A. Teukolsky, and W. T. Vettering, Numerical Recipes, [Cambridge Press, New York, 1986].

7 Particle-in-cell method PIC algorithm Particle du/dt 9.3% time, 216 lines Integration of equations of motion, moving particles F i u i x i Particle dx/dt 5.3% time, 139 lines Field interpolation 42.9% time, 290 lines Interpolation ( E, B ) j F i Δt Current Deposition (x,u) j J j Current deposition 35.3% time, 609 lines Integration of Field Equations on the grid J j ( E, B ) j The particle-in-cell method treats plasma as a collection of computer particles. The interactions does not scale as N 2 due to the fact the particle quantities are deposited on a grids and the interactions are calculated on the grids only. Because (# of particles) >> (# of grids), the timing is dominated by the particle calculations (orbit calculation + current & charge deposition). The grid filters out short-range forces. This approximation is valid because the plasma is fairly collisions and short range forces are not important. In systems where short range interactions are important, a binary collision model can be added back as an additional block after the orbit integration.

8 Inter-particle interactions In PIC models, the E and B fields are functions of the particle quantities such as charge and current densities, and then the particle orbits are updated using the updated electric and magnetic fields. However, the equations for the field can vary depending on the choice of the field model. For today s demos, we will use two different models. Electrostatic (e.g. BEPS): r E = Electromagnetic ~ E = ~ J + r ~ B = r ~ E

9 Note on Notations: Because the systems are discretized in space and time, there are a lot of indices flying around in this talk. So before I begin, I will describe the notations used in this talk. For the rest of the class I will use the following notations: (1) i superscript to indicate time, and j subscript for the j-th particle (for particle quantities such as coordinates or momentum). ~x i j ~x j (t = i t) (2) for grid quantities, the superscript i indicates the time and English subscript indicates the grid coordinate. (3) in some of the codes, the grid quantity is transformed to wave number (k) space via Fast Fourier Transforms, in that case the grid indices are indicated by Greek alphabets, shown below: The smallest wavenumber k, is the mode where the wavelength is exactly the length of the simulation box N x x = L x k x = N x 2 i a,b i (a x, b y) i, i ( k x, k y ) x k y = N y 2 y

10 Short Note on resolution/uncertainty Although there is very little discussion (~2-3 slides) on discrete Fourier transforms, or the a > α notation in the previous slide, the issue of resolution (or uncertainty) is an important one for the rest of this talk. When a system is discretized in space and time like the PIC model, the largest frequency/wavenumber that can be sampled by our choice of dx/dt changes correspondingly. Assuming a system of length L x, discretized into Nx grids, each one of size dx, (and consider a variable φ a, which is defined on these grids). L x = N x dx The lowest wavelength that can be resolved by a system with length L x is: k 0 = 2 the largest frequency, known as the Nyquist frequency, is one which the wavelength is two grids wide. For L x k max = dx = N x 2 k 0 So in k-space, there are also Nx modes, spanning from -kmax to kmax. And the discrete Fourier transform where φ a is transformed to φ α can be described by a matrix multiplication. ~ = M a, ~a a 2 [1,N x ] 2 [ N x /2+1,N x /2] M a, =exp[ik x a ] So, when you introduce discretization in real space, you also limits yourself to the waves behaviors that you can sample. This is something to keep in mind when you design your simulation, but as you will see, we operate far below the Nyquist limit

11 I Interpolating grid quantities on particles/shape functions Another consequence of using grids is that particles cannot be point charges anymore. In particle-in-cell methods, particles are not point charges as point charges cannot be detected by the grid. In order for particles to deposit its charge/ current on the grids (and conversely, for the particles to feel the interactions from the electric & magnetic fields on the grid), the particles need to be of a finite shape. Some common shape functions are: Nearest grid, linear weighting, quadratic spline (these all belong to a family of functions called b-splines, shown on the right), Nearest grid is b-spline of the N-th order is N grid wide (e.g., nearest grid is one grid wide, linear weight is 2 grids wide, etc.) Charge interpolation is written in terms of these shape functions as: (x) = X (q j /V g )S(x x j ) j Having higher order splines can reduce noise, as it allows the code to average over a few grids and this reduces noise from particle statistics Take the system on the right. The effects of particle clumping due to statistical variations can be minimized by using higher order splines. However, this comes at a cost.

12 Particle Shape Function (cont) With the shape function, the grid quantities can be derived from particle positions via the formula: (x) = X j (q j /V g )S(x x j ) By replacing the delta function with the shape function, it can be shown that the cold plasma dispersion becomes (see p. 66 of Birdsall & Langdon).! 2 =! 2 p S(k) 2 k x apple 0.5 (for plasma waves) For the n-th order b-spline, the shape function in Fourier space is: S n (k) = apple sin(k x/2) k x/2 n+1 Therefore, the particle s shape function acts as a filter in Fourier space, and particle s density at large k is effectively less due to the filter effects of the shape function. (A word of caution: because S(x) is a continuous function and the grids are defined at fixed intervals and is subjected to the Nyquist limit, particle shape function at k beyond the Nyquist limit still contributes to the plasma dispersion relation via aliasing, which can be a source of instability (but we do not have time to go into this much detail today but it is a very active topic of research. (we will have a similar requirement for EM waves later)

13 Interpolation Summary Higher order splines are attractive because it reduces statistical fluctuation by spreading the particle over several cells wide it reduces aliasing, and can lead to less numerical problems. However, having larger particle shape introduces finite particle shape S(k) effects into the numerical dispersion relation

14 II Orbit Calculation Leapfrog method Once the current/charge is calculated, and the electric and magnetic fields are calculated, the particle orbits can be advanced via Newton s equation. ( d~xj dt = ~v j d~v j dt = q ~ m E(~x j ) The particle orbits are integrated using the leap-frog method, which is simply the mid-point method for integrating the ODE below. Therefore, to solve the equation above, and to advance the particle s position by one tilmestep, take the velocity at a time between the old time-step and the new time-step, and approximately, the new position becomes: x i+1 j dx dt = v = x i j + v i+1/2 j + Error We will quantify the error in a slide or two.

15 Leap-Frog (cont) However, when the mid-point method is applied to a pair of coupled variables (x,v) which is a function of each other, as shown below: ( d~xj dt = ~v j d~v j dt = q ~ m E(~x j ) then the solution becomes: ~x i+1 j ~v i+3/2 j = ~x i j + ~v i+1/2 j = ~v i+1/2 j + q j m j ( ~ E j+1 (~x j+1 j )) and each particle s position and velocity needs to be staggered by 1/2 step in time in order to perform the integration, and that s how the scheme get its name. The leap-frog method is clean and straight forward with only the electric field, it can incorporate the (vxb) force easily, and the relativistic version of the above equation can also be solved. This is discussed in Birdsall and Langdon and we ll skip it here due to time constrains.

16 Leap Frog Integration (cont) The leap-frog integration method for solving ODE s is remarkable because it is second order accurate in spite of the fact that it only evaluates the time derivative at one point in time. By comparison, both the forward and backward Euler method is only first order accurate. Now, consider trying to march the following ODE in time over a step-size of t. dx dt = f(t) (backward Euler) - 1st order x i+1 = x i + t(f i + O( t)) (forward Euler) 1st order x i+1 = x i + t(f i+1 + O( t)) By evaluating f at the mid-point, the leap-frog scheme is second order accurate. x i+1 = x i + t(f i+1/2 + O( t 2 )) Because this method is second order accurate at each time-step, the cumulative error is first order in t and vanishes as t goes to 0. However, the numerical method is said to be consistent if it is more than second order accurate and is numerically stable. I will talk about the stability condition of the leapfrog scheme next.

17 Stability Condition of the Leap-Frog Method and the Fibonacci Series The stability condition of an ODE solver can be derived by studying the amplifying factors of infinite series. Perhaps some of you have seen an example of this, via the very famous Fibonacci series. x i+2 = x i+1 + x i x 1 =1,x 2 =1 lim i!1 x i = 1+ p 5 2 x i this number, is also known as the Golden Ratio and can be derived by converting the above series into a polynomial (which I will talk about in the next slide). A numerical scheme is said to be stable if the ratio below (called the amplification factor) lies inside the unit circle in the complex plane. This condition insures that the integration errors do not get amplified by the integration scheme. A xi+1 x i apple1

18 Leapfrog stability: I For the leapfrog scheme, let s consider a wave-like equation, i.e., dx dt = i! x Then the leapfrog scheme becomes a series of the form: x i+1 = x i +(i! t)x i+1/2 To calculate the amplification factor, assumes that the series is a function of A (like the Fibonacci series) in the following sense: x i = CA i Then the above series becomes a second order polynomial if you assume (like the Fibonacci series), the series depends on A, as follows: A 2 (i! t)a 1=0

19 Leapfrog Stability: II From Quadratic formula, the amplification A, is: A = (i! t) 2 ± s And therefore the stability condition for the leapfrog method is simply:! t apple 2 1 (i! t) 2 2 Typically, we choose tilmestep of the size: t apple 0.3 [1/! pe ] For magnetized plasmas, the requirement depends on the either the plasma frequency or the cyclotron frequency, depending on which one is higher. t apple 0.3 min(1/! pe, 1/ ce ) For systems with very high intensity lasers (where the wiggle velocity is very large), the step size requirement is even more strict, and is an topic of current research.

20 (Numerical Stability, cont) by contrast, the backward Euler s method is always unstable w.r.t. the model equation, whereas the forward Euler s method is always stable: dx dt = i! x Backward Euler (1st order, unconditionally unstable): x i+1 =(1+i! t)x i A = p 1+! 2 t 2 Forward Euler (1st order, uncoditionally stable): x i = (1 + i! t) xi A = p 1+! 2 t 2

21 III Field Solver for EM field models However, if you want to incorporate laser into your model, you need to solve the full Maxwell s equation. For EM systems, we will will evolve E and B via the two curl equations (we will adopt the OSIRIS normalization of c=1 from this point on), like position and velocity, the electric and magnetic fields of the system can evolve using the leap-frog method using these two equations: Like position and velocity in the particle push, the time derivative of E depends on B and vice versa, so E and B can be advanced in time using the leap-frog method, in the same way as x and v for ~ = r ~ ~ = r ~ E ~ J ~E ~B i i+1 i+2 i+1/2 i+3/2 i+5/2 (time)

22 Courant Condition Independent of the method used to solve Maxwell s equation, all schemes must satisfy the Courant condition. In 1D, it is: i.e., light-wave cannot move more than one cell per timestep. In higher dimensions, it is more complicated: For square (2D) and cubic (3D) grids, the Courant condition for solving Maxwell s equations is: (c) t< 1 p 2 (c) t< x (c) t< x 1 pp i 1/x2 i (c) t< 1 p 3 x respectively

23 FDTD method for EM systems In space, the spatial derivative is done using the midpoint (as it is done in time) because of its good numerical a x a 1 x ( a+1/2 a 1/2)+O( x 2 ) The mid-point method requires the E s and B s to be laid out in a complicated mesh (shown on the right), called the Yee-grid (discovered by Kane Yee in 1966*), but it is fairly straight forward to implement. The x operator is second order accurate, and in Fourier space, instead of (ik), the eigenvalue of the x operator is: x 2sin(k (k) =ik x/2) k x/2 ik (from Wikipedia) apple k2 x 2 (error is second order in x) *

24 Numerical Dispersion Now, putting everything we ve learned so far together, it can be shown that EM waves in this system obeys the dispersion relation: t(!) 2 =! 2 pes(k) 2 + x (k) 2 t (!) = i! 2sin(! t/2)! t/2 which takes into accounts the effects of finite timestep and finite grid size, and also take into account the particle shape. The above equation can be solved numerically and the effects of the grids can be tested before the simulations are performed. (You can also Taylor expand the above equation and solve the polynomial analytically to get some insights). x 2sin(k (k) =ik x/2) k x/2 apple ik k2 x 2

25 Numerical Dispersion (cont) On the top right is the Mathematica prediction of a short pulse propagation in a underdense plasma, n=0.01n c. (dt=0.95 dx). Theory predicts that for kdx<0.3, the agreement between numerical solution and theory (shown in black) is quite good. However, for k x = 0.8, the numerical phase velocity is much smaller than the phase velocity of the real plasma, and the numerical solution deviates from the Exact solution. Lower right shows that OSIRIS results agree very well with theoretical predictions, the pink wiggle on the left of the plot is due to the periodic boundary condition in the Mathematica script. The low k modes of the laser moves to the back of the simulation box but then comes back to the front.

26 Numerical Dispersion (final) So, from the previous slide, one can deduce that the grid acts as a dielectric with different dielectric constants for different k x. (i.e., at large k x, light moves at a velocity slightly slower than it would in a real plasma) This will cause non-physical radiations in systems where there are relativistic beams. We are looking into ways to mitigate this unphysical radiation (numerical Cherenkov)

27 Numerical Cherenkov Radiation Langmuir modes / EM modes coupling

28 Modeling relativistically drifting plasma in EM-PIC code LWFA in Lorentz boosted frame: A way to save time by studying a system in a Lorentz boosted frame. In this case, the plasma is moving near the speed of light. Relativistic collisionless shock: In the simulation below, two relativistically moving plasmas collide with each other, and (nonphysical) radiation develops before the collision happens.

29 hybrid Yee-FFT solver OSIRIS: FDTD solver UPIC-EMMA: spectral solver [k 1 ]= sin(k 1 x 1 /2) x 1 /2 [k 1 ]=k 1 [k 2 ]= sin(k 2 x 2 /2) x 2 /2 [k 2 @x 2 Hybrid solver [k 2 ]= sin(k 2 x 2 /2) x 2 /2 [k 1 ]=k 1 Can be extended to quasi-3d Can use flexible boundary condition in x2 Makes OSIRIS usable.

30 LWFA 3D boosted frame simulation 1.3 GeV 3D simulation NCI elimination applied 3D Simulation parameters grid size: x 1,2,3 =0.196 time step: Boosted frame: t =0.184 x 1 = 15

31 Collisionless relativistic shock Eliminate unphysical energy exchange between EM modes and Langmuir mode log B3 Yee v.s. FFT based solver 2D shock simulation NCI elimination applied 2D Simulation parameters grid size: x 1 =0.5 k0 1 time step: t =0.125 x 1 Drifting velocity: = 20

32 Demos Linear + Nonlinear Landau Damping (BEPS) Beam-Plasma Instability (BEPS) Two Plasmon Instability (OSIRIS)

33 UCLA Particle-in-Cell and Kinetic Simulation Software Center (PICKSC), NSF funded center whose Goal is to provide and document parallel Particle-in-Cell (PIC) and other kinetic codes. Planned activities Provide parallel skeleton codes for various PIC codes on traditional and new parallel hardware and software systems. Provide MPI-based production PIC codes that will run on desktop computers, mid-size clusters, and the largest parallel computers in the world. Provide key components for constructing new parallel production PIC codes for electrostatic, electromagnetic, and other codes. Provide interactive codes for teaching of important and difficult plasma physics concepts Facilitate benchmarking of kinetic codes by the physics community, not only for performance, but also to compare the physics approximations used Documentation of best and worst practices, which are often unpublished and get repeatedly rediscovered. Provide some services for customizing software for specific purposes (based on our existing codes) Key components and codes will be made available through standard open source licenses and as an open-source community resource, contributions from others are welcome.

34 Outline What is PIC? Some examples of large PIC simulations (HED and non-hed) and what are systems which are appropriate for PIC simulations? Various parts of the PIC code, how is each part implemented and how do you design a good simulation based on the numerical scheme used in PIC codes? Interpolation Particle Orbit Calculation Field Calculation Numerical Cherenkov Radiation - How do we mitigate it so we can study relativistic shocks, and study LWFA s in Lorentz boosted frames

35 Extra Slides

36 Boris Pusher: The particle s velocity advance is more complicated when there is a magnetic field (either an external magnetic field or a self-consistent one

37 Boris Pusher (cont)

38 Leap Frog Integration (cont) For the leapfrog scheme, let s consider a wave-like equation, i.e., dx dt = i! x Then the leapfrog scheme becomes a series of the form: x i+1 = x i +(i! t)x i+1/2 To calculate the amplification factor, assumes that the series is a function of A x i = CA i Then the above series becomes a second order polynomial if you assume (like A 2 (i! t)a 1=0 From Quadratic formula, the amplification A, is: A = (i! t) 2 ± s 1 (i! t) 2 2 And therefore the stability condition for the leapfrog method is simply: Typically, we choose tilmestep of the size: For systems with very high intensity lasers (where the wiggle velocity is very t apple 0.3 [1/! pe ]

39 Field Solver for ES field models For studying the plasma wave, the self-consistent magnetic field is ignored and only the electrostatic field is evolved when the particle moves from one step to the next, via the = The above equation can be solved in coordinate space by integrating both sides along x (with ONE boundary condition), or, in most cases, it is solved in k space by the equation. (E x ) = k k = 2 L x In k space, the k=0 mode cannot be solved and is determined by the boundary condition, this is analogous to needing ONE boundary condition in coordinate space. (In higher dimension usually one solves Poisson s equation and then solve for the electric fields)

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

arxiv: v1 [physics.comp-ph] 4 Feb 2015

arxiv: v1 [physics.comp-ph] 4 Feb 2015 arxiv:1502.01376v1 [physics.comp-ph] 4 Feb 2015 Mitigation of numerical Cerenkov radiation and instability using a hybrid finite difference-fft Maxwell solver and a local charge conserving current deposit

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

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

arxiv: v1 [physics.plasm-ph] 24 Oct 2015

arxiv: v1 [physics.plasm-ph] 24 Oct 2015 Lorentz boosted frame simulation of Laser wakefield acceleration in quasi-3d geometry arxiv:1510.07110v1 [physics.plasm-ph] 24 Oct 2015 Peicheng Yu a, Xinlu Xu a,b, Asher Davidson b, Adam Tableman b, Thamine

More information

Kinetic Plasma Simulations. Anatoly Spitkovsky (Princeton)

Kinetic Plasma Simulations. Anatoly Spitkovsky (Princeton) Kinetic Plasma Simulations Anatoly Spitkovsky (Princeton) Contents Plasma physics on computers How PIC works Electrostatic codes Charge assignment and shape factors Discretization effects Electromagnetic

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

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

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

PHYSICS Computational Plasma Physics

PHYSICS Computational Plasma Physics PHYSICS 78 - Computational Plasma Physics INSTRUCTOR Dr. Earl Scime (escime@wvu.edu) 93-34, ext. 1437 Office hours: MW :30 3:30 and whenever door is open Rm 18 & 05 Hodges Hall Class: MWF 1:30-:0 Rm 334

More information

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

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

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

Petascale Particle-in-Cell Simulation of Laser Plasma Interactions in High Energy Density Plasmas on Blue Waters

Petascale Particle-in-Cell Simulation of Laser Plasma Interactions in High Energy Density Plasmas on Blue Waters Petascale Particle-in-Cell Simulation of Laser Plasma Interactions in High Energy Density Plasmas on Blue Waters Frank Tsung Viktor K. Decyk Weiming An Xinlu Xu Diana Amorim (IST) Warren Mori (PI) OUTLINE/SUMMARY

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

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

Simulations of Plasmas with Electrostatic PIC Models Using the Finite Element Method

Simulations of Plasmas with Electrostatic PIC Models Using the Finite Element Method Brazilian Journal of Physics, vol. 33, no., June, 003 411 Simulations of Plasmas with Electrostatic PIC Models Using the Finite Element Method A. C. J. Paes, N. M. Abe, V. A. Serrão, and A. Passaro Instituto

More information

Summer College on Plasma Physics. 30 July - 24 August, The forming of a relativistic partially electromagnetic planar plasma shock

Summer College on Plasma Physics. 30 July - 24 August, The forming of a relativistic partially electromagnetic planar plasma shock 1856-31 2007 Summer College on Plasma Physics 30 July - 24 August, 2007 The forming of a M. E. Dieckmann Institut fuer Theoretische Physik IV, Ruhr-Universitaet, Bochum, Germany The forming of a The forming

More information

Heating and current drive: Radio Frequency

Heating and current drive: Radio Frequency Heating and current drive: Radio Frequency Dr Ben Dudson Department of Physics, University of York Heslington, York YO10 5DD, UK 13 th February 2012 Dr Ben Dudson Magnetic Confinement Fusion (1 of 26)

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

Intro. Lecture 04: Numerical Methods for Particle and Distribution Methods: Introduction to the PIC Method *

Intro. Lecture 04: Numerical Methods for Particle and Distribution Methods: Introduction to the PIC Method * Intro. Lecture 04: Numerical Methods for Particle and Distribution Methods: Introduction to the PIC Method * Prof. Steven M. Lund Physics and Astronomy Department Facility for Rare Isotope Beams (FRIB)

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

Computer Simulation Using Particles

Computer Simulation Using Particles Computer Simulation Using Particles R W Hockney Emeritus Professor, University ofreading and J W Eastwood Culham Laboratory, Abingdon Institute of Physics Publishing Bristol and Philadelphia CONTENTS Foreword

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

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

High Order Semi-Lagrangian WENO scheme for Vlasov Equations

High Order Semi-Lagrangian WENO scheme for Vlasov Equations 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

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

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

Intro. Lecture 04: Numerical Methods for Particle and Distribution Methods: Introduction to the PIC Method *

Intro. Lecture 04: Numerical Methods for Particle and Distribution Methods: Introduction to the PIC Method * Intro. Lecture 04: Numerical Methods for Particle and Distribution Methods: Introduction to the PIC Method * Prof. Steven M. Lund Physics and Astronomy Department Facility for Rare Isotope Beams (FRIB)

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

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

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

Transformative Petascale Particle-in-Cell Simulation of Laser Plasma Interactions on Blue Waters

Transformative Petascale Particle-in-Cell Simulation of Laser Plasma Interactions on Blue Waters Transformative Petascale Particle-in-Cell Simulation of Laser Plasma Interactions on Blue Waters Frank Tsung Viktor K. Decyk Weiming An Xinlu Xu Han Wen Warren Mori (PI) Special Thanks to Galen Arnold

More information

(Refer Slide Time: 03: 09)

(Refer Slide Time: 03: 09) Computational Electromagnetics and Applications Professor Krish Sankaran Indian Institute of Technology Bombay Lecture No 26 Finite Volume Time Domain Method-I Welcome back in the precious lectures we

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

Speeding up simulations of relativistic systems using an optimal boosted frame

Speeding up simulations of relativistic systems using an optimal boosted frame Speeding up simulations of relativistic systems using an optimal boosted frame J.-L. Vay1,3, W.M. Fawley1, C. G. R. Geddes1, E. Cormier-Michel1, D. P. Grote2,3 1Lawrence Berkeley National Laboratory, CA

More information

Special Theory of Relativity Prof. Shiva Prasad Department of Physics Indian Institute of Technology, Bombay

Special Theory of Relativity Prof. Shiva Prasad Department of Physics Indian Institute of Technology, Bombay Special Theory of Relativity Prof. Shiva Prasad Department of Physics Indian Institute of Technology, Bombay Lecture - 24 Current Density Four Vector and Maxwell Equation Hello, so we have now come to

More information

Understanding the pulsar magnetosphere through first-principle simulations

Understanding the pulsar magnetosphere through first-principle simulations Understanding the pulsar magnetosphere through first-principle simulations Alexander Y. Chen In collaboration with: Andrei Beloborodov Rui Hu The Many Faces of Neutron Stars August 25, 2015 Pulsars: Rotating

More information

Physics 11b Lecture #24. Quantum Mechanics

Physics 11b Lecture #24. Quantum Mechanics Physics 11b Lecture #4 Quantum Mechanics What We Did Last Time Theory of special relativity is based on two postulates: Laws of physics is the same in all reference frames Speed of light is the same in

More information

2.1 The Ether and the Michelson-Morley Experiment

2.1 The Ether and the Michelson-Morley Experiment Chapter. Special Relativity Notes: Some material presented in this chapter is taken The Feynman Lectures on Physics, Vol. I by R. P. Feynman, R. B. Leighton, and M. Sands, Chap. 15 (1963, Addison-Wesley)..1

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

External injection of electron bunches into plasma wakefields

External injection of electron bunches into plasma wakefields External injection of electron bunches into plasma wakefields Studies on emittance growth and bunch compression p x x Timon Mehrling, Julia Grebenyuk and Jens Osterhoff FLA, Plasma Acceleration Group (http://plasma.desy.de)

More information

Fundamentals Physics

Fundamentals Physics Fundamentals Physics And Differential Equations 1 Dynamics Dynamics of a material point Ideal case, but often sufficient Dynamics of a solid Including rotation, torques 2 Position, Velocity, Acceleration

More information

Introduction to Particle-in-Cell Method in Plasma Simulations

Introduction to Particle-in-Cell Method in Plasma Simulations Introduction to Particle-in-Cell Method in Plasma Simulations Chuang Ren University of Rochester The 2009 HEDP Summer School Acknowledgement: V. Decyk, R. Fonseca, W. Mori, J. Tonge, F. Tsung 1 Simulation

More information

Speeding up simulations of relativistic systems using an optimal boosted frame

Speeding up simulations of relativistic systems using an optimal boosted frame Speeding up simulations of relativistic systems using an optimal boosted frame J.-L. Vay1,3, W. M. Fawley1, C. G. R. Geddes1, E. Cormier-Michel1, D. P. Grote2,3 1Lawrence Berkeley National Laboratory,

More information

Lecture V: The game-engine loop & Time Integration

Lecture V: The game-engine loop & Time Integration Lecture V: The game-engine loop & Time Integration The Basic Game-Engine Loop Previous state: " #, %(#) ( #, )(#) Forces -(#) Integrate velocities and positions Resolve Interpenetrations Per-body change

More information

Anisotropic electron distribution functions and the transition between the Weibel and the whistler instabilities

Anisotropic electron distribution functions and the transition between the Weibel and the whistler instabilities Anisotropic electron distribution functions and the transition between the Weibel and the whistler instabilities F. Pegoraro, L. Palodhi, F. Califano 5 th INTERNATIONAL CONFERENCE ON THE FRONTIERS OF PLASMA

More information

Beam-Beam Simulations for e + e Colliders

Beam-Beam Simulations for e + e Colliders Beam-Beam Simulations for e + e Colliders J. Rogers, Cornell University Motivation for simulations from observed effects Methods algorithms, simulation codes, and some results. Conclusions Brown Bag Seminar,

More information

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

A fully implicit, exactly conserving algorithm for multidimensional particle-in-cell kinetic simulations 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

More information

Simulating radiation from Laser-wakefield accelerators

Simulating radiation from Laser-wakefield accelerators TUSBC1 11 th International Computational Accelerator Physics Conference ICAP 2012 in Rostock Simulating radiation from Laser-wakefield accelerators Alexander Debus, Richard Pausch, René Widera, Michael

More information

Non-neutral fireball and possibilities for accelerating positrons with plasma

Non-neutral fireball and possibilities for accelerating positrons with plasma Instituto Superior Técnico GoLP/IPFN Non-neutral fireball and possibilities for accelerating positrons with plasma J.Vieira GoLP / Instituto de Plasmas e Fusão Nuclear Instituto Superior Técnico, Lisbon

More information

ASTR 610 Theory of Galaxy Formation Lecture 4: Newtonian Perturbation Theory I. Linearized Fluid Equations

ASTR 610 Theory of Galaxy Formation Lecture 4: Newtonian Perturbation Theory I. Linearized Fluid Equations ASTR 610 Theory of Galaxy Formation Lecture 4: Newtonian Perturbation Theory I. Linearized Fluid Equations Frank van den Bosch Yale University, spring 2017 Structure Formation: The Linear Regime Thus far

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

Development of a stable coupling of the Yee scheme with linear current

Development of a stable coupling of the Yee scheme with linear current Development of a stable coupling of the Yee scheme with linear current Martin Campos Pinto (LJLL), Bruno Després (LJLL) Stéphane Heuraux (IJL), Filipe Da Silva (IPFN+IST) 15 octobre 2013 Munich: Pereverzev

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

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

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

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

Multiscale Modelling, taking into account Collisions

Multiscale Modelling, taking into account Collisions Multiscale Modelling, taking into account Collisions Andreas Adelmann (Paul Scherrer Institut) October 28, 2017 Multiscale Modelling, taking into account Collisions October 28, 2017 Page 1 / 22 1 Motivation

More information

Plasma Physics Prof. V. K. Tripathi Department of Physics Indian Institute of Technology, Delhi

Plasma Physics Prof. V. K. Tripathi Department of Physics Indian Institute of Technology, Delhi Plasma Physics Prof. V. K. Tripathi Department of Physics Indian Institute of Technology, Delhi Module No. # 01 Lecture No. # 22 Adiabatic Invariance of Magnetic Moment and Mirror Confinement Today, we

More information

Numerical simulation methods for laser target interactions

Numerical simulation methods for laser target interactions Numerical simulation methods for laser target interactions Jiří Limpouch Czech Technical University in Prague Faculty of Nuclear Sciences & Physical Engineering Brehova 7, 115 19 Praha 1, Czechia jiri.limpouch@fjfi.cvut.cz

More information

Modeling Nonlinear Optics Of Plasmas (Relevant To IFE)

Modeling Nonlinear Optics Of Plasmas (Relevant To IFE) Modeling Nonlinear Optics Of Plasmas (Relevant To IFE) F.S.Tsung and the UCLA Simulation Group University of California, Los Angeles (UCLA) 1 F. S. Tsung/OSIRIS Workshop 2017 Summary/Conclusion Introduction

More information

Numerical Modelling in Fortran: day 10. Paul Tackley, 2016

Numerical Modelling in Fortran: day 10. Paul Tackley, 2016 Numerical Modelling in Fortran: day 10 Paul Tackley, 2016 Today s Goals 1. Useful libraries and other software 2. Implicit time stepping 3. Projects: Agree on topic (by final lecture) (No lecture next

More information

FRAME S : u = u 0 + FRAME S. 0 : u 0 = u À

FRAME S : u = u 0 + FRAME S. 0 : u 0 = u À Modern Physics (PHY 3305) Lecture Notes Modern Physics (PHY 3305) Lecture Notes Velocity, Energy and Matter (Ch..6-.7) SteveSekula, 9 January 010 (created 13 December 009) CHAPTERS.6-.7 Review of last

More information

Research on Structure Formation of Plasmas Dominated by Multiple Hierarchical Dynamics

Research on Structure Formation of Plasmas Dominated by Multiple Hierarchical Dynamics Chapter 4 Epoch Making Simulation Research on Structure Formation of Plasmas Dominated by Multiple Hierarchical Dynamics Group Representative Yasuaki Kishimoto Naka Fusion Research Establishment, Japan

More information

DOING PHYSICS WITH MATLAB

DOING PHYSICS WITH MATLAB DOING PHYSICS WITH MATLAB ELECTROMAGNETISM USING THE FDTD METHOD [1D] Propagation of Electromagnetic Waves Matlab Download Director ft_3.m ft_sources.m Download and run the script ft_3.m. Carefull inspect

More information

The Weibel Instability in Collisionless Relativistic Shocks

The Weibel Instability in Collisionless Relativistic Shocks The Weibel Instability in Collisionless Relativistic Shocks Tanim Islam University of Virginia The Weibel instability[1], purely electromagnetic in nature, has been used to explain the strong magnetic

More information

Part E1. Transient Fields: Leapfrog Integration. Prof. Dr.-Ing. Rolf Schuhmann

Part E1. Transient Fields: Leapfrog Integration. Prof. Dr.-Ing. Rolf Schuhmann Part E1 Transient Fields: Leapfrog Integration Prof. Dr.-Ing. Rolf Schuhmann MAXWELL Grid Equations in time domain d 1 h() t MC e( t) dt d 1 e() t M Ch() t j( t) dt Transient Fields system of 1 st order

More information

Welcome back to PHY 3305

Welcome back to PHY 3305 Welcome back to PHY 3305 Today s Lecture: Momentum and Energy Conservation Albert Einstein 879-955 Review: Transforming Velocity Remember: u = dx dt x = γ ν (x + vt ) t = γ ν ( v c 2 x + t ) From this

More information

Brad Gibson Centre for Astrophysics & Supercomputing Swinburne University

Brad Gibson Centre for Astrophysics & Supercomputing Swinburne University N-body Simulations: Tree and Mesh Approaches Brad Gibson Centre for Astrophysics & Supercomputing Swinburne University Demystifying the Jargon Trees Collisionless Boltzmann Equation Symplectic Time Integration

More information

Kinetics of the Raman Instability in a Laser Plasma

Kinetics of the Raman Instability in a Laser Plasma WDS'05 Proceedings of Contributed Papers, Part II, 383 390, 2005. ISBN 80-86732-59-2 MATFYZPRESS Kinetics of the Raman Instability in a Laser Plasma M. Mašek and K. Rohlena Institute of Physics, Academy

More information

Numerical differentiation

Numerical differentiation Numerical differentiation Paul Seidel 1801 Lecture Notes Fall 011 Suppose that we have a function f(x) which is not given by a formula but as a result of some measurement or simulation (computer experiment)

More information

Model Order Reduction and Stability Enforcement of Finite-Difference Time-Domain Equations Beyond the CFL Limit. Xihao Li

Model Order Reduction and Stability Enforcement of Finite-Difference Time-Domain Equations Beyond the CFL Limit. Xihao Li Model Order Reduction and Stability Enforcement of Finite-Difference Time-Domain Equations Beyond the CFL Limit by Xihao Li A thesis submitted in conformity with the requirements for the degree of Master

More information

Part 1. The diffusion equation

Part 1. The diffusion equation Differential Equations FMNN10 Graded Project #3 c G Söderlind 2016 2017 Published 2017-11-27. Instruction in computer lab 2017-11-30/2017-12-06/07. Project due date: Monday 2017-12-11 at 12:00:00. Goals.

More information

Ordinary Differential Equations

Ordinary Differential Equations Ordinary Differential Equations We call Ordinary Differential Equation (ODE) of nth order in the variable x, a relation of the kind: where L is an operator. If it is a linear operator, we call the equation

More information

VLASOV1: One-dimensional electrostatic Vlasov code Hands-on session in 13th International School for Space Simulations (ISSS-13)

VLASOV1: One-dimensional electrostatic Vlasov code Hands-on session in 13th International School for Space Simulations (ISSS-13) VLASOV1: One-dimensional electrostatic Vlasov code Hands-on session in 13th International School for Space Simulations (ISSS-13) Takayuki Umeda Ver.2: September 6, 2018 for ISSS-13@UCLA, USA Ver.1: July

More information

Analytic Benchmarking of the 2DX eigenvalue code

Analytic Benchmarking of the 2DX eigenvalue code Analytic Benchmarking of the 2DX eigenvalue code D. A. Baver, J. R. Myra Lodestar Research Corporation M. Umansky Lawrence Livermore National Laboratory Analytic benchmarking of the 2DX eigenvalue code

More information

Notes on numerical solution of differential equations

Notes on numerical solution of differential equations Notes on numerical solution of differential equations Some definitions, for those who don t know: A differential equation is any equation that relates a thing to its derivatives. For instance, Newton s

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

Lecture 17: Initial value problems

Lecture 17: Initial value problems Lecture 17: Initial value problems Let s start with initial value problems, and consider numerical solution to the simplest PDE we can think of u/ t + c u/ x = 0 (with u a scalar) for which the solution

More information

Radiation processes and mechanisms in astrophysics I. R Subrahmanyan Notes on ATA lectures at UWA, Perth 18 May 2009

Radiation processes and mechanisms in astrophysics I. R Subrahmanyan Notes on ATA lectures at UWA, Perth 18 May 2009 Radiation processes and mechanisms in astrophysics I R Subrahmanyan Notes on ATA lectures at UWA, Perth 18 May 009 Light of the night sky We learn of the universe around us from EM radiation, neutrinos,

More information

Novel Simulation Methods in the code-framework Warp

Novel Simulation Methods in the code-framework Warp Novel Simulation Methods in the code-framework Warp J.-L. Vay1,3, D.P. Grote2,3, R.H. Cohen2,3, A. Friedman2,3, S.M. Lund2,3, E. Cormier-Michel1, W.M. Fawley1, M.A. Furman1, C.G.R. Geddes1 1Lawrence Berkeley

More information

Advection / Hyperbolic PDEs. PHY 604: Computational Methods in Physics and Astrophysics II

Advection / Hyperbolic PDEs. PHY 604: Computational Methods in Physics and Astrophysics II Advection / Hyperbolic PDEs Notes In addition to the slides and code examples, my notes on PDEs with the finite-volume method are up online: https://github.com/open-astrophysics-bookshelf/numerical_exercises

More information

Particle-In-Cell Code for Two-Stream Instability

Particle-In-Cell Code for Two-Stream Instability 7// PIC codes Two-stream instability Particle-In-Cell Code for Two-Stream Instability This exercise uses the previously-developed PIC code to investigate the two-stream instability. The electron distribution

More information

What is proof? Lesson 1

What is proof? Lesson 1 What is proof? Lesson The topic for this Math Explorer Club is mathematical proof. In this post we will go over what was covered in the first session. The word proof is a normal English word that you might

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

Lecture IV: Time Discretization

Lecture IV: Time Discretization Lecture IV: Time Discretization Motivation Kinematics: continuous motion in continuous time Computer simulation: Discrete time steps t Discrete Space (mesh particles) Updating Position Force induces acceleration.

More information

Partial differential equations

Partial differential equations Partial differential equations Many problems in science involve the evolution of quantities not only in time but also in space (this is the most common situation)! We will call partial differential equation

More information

CSR calculation by paraxial approximation

CSR calculation by paraxial approximation CSR calculation by paraxial approximation Tomonori Agoh (KEK) Seminar at Stanford Linear Accelerator Center, March 3, 2006 Short Bunch Introduction Colliders for high luminosity ERL for short duration

More information

Explanations of animations

Explanations of animations Explanations of animations This directory has a number of animations in MPEG4 format showing the time evolutions of various starting wave functions for the particle-in-a-box, the free particle, and the

More information

(Refer Slide Time: 01:11) So, in this particular module series we will focus on finite difference methods.

(Refer Slide Time: 01:11) So, in this particular module series we will focus on finite difference methods. Computational Electromagnetics and Applications Professor Krish Sankaran Indian Institute of Technology, Bombay Lecture 01 Finite Difference Methods - 1 Good Morning! So, welcome to the new lecture series

More information

Time scales. Notes. Mixed Implicit/Explicit. Newmark Methods [ ] [ ] "!t = O 1 %

Time scales. Notes. Mixed Implicit/Explicit. Newmark Methods [ ] [ ] !t = O 1 % Notes Time scales! For using Pixie (the renderer) make sure you type use pixie first! Assignment 1 questions?! [work out]! For position dependence, characteristic time interval is "!t = O 1 % $ ' # K &!

More information

Multi-fluid Simulation Models for Inductively Coupled Plasma Sources

Multi-fluid Simulation Models for Inductively Coupled Plasma Sources Multi-fluid Simulation Models for Inductively Coupled Plasma Sources Madhusudhan Kundrapu, Seth A. Veitzer, Peter H. Stoltz, Kristian R.C. Beckwith Tech-X Corporation, Boulder, CO, USA and Jonathan Smith

More information

Comparison of Kinetic and Extended MHD Models for the Ion Temperature Gradient Instability in Slab Geometry

Comparison of Kinetic and Extended MHD Models for the Ion Temperature Gradient Instability in Slab Geometry Comparison of Kinetic and Extended MHD Models for the Ion Temperature Gradient Instability in Slab Geometry D. D. Schnack University of Wisconsin Madison Jianhua Cheng, S. E. Parker University of Colorado

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

Basics of Radiation Fields

Basics of Radiation Fields Basics of Radiation Fields Initial questions: How could you estimate the distance to a radio source in our galaxy if you don t have a parallax? We are now going to shift gears a bit. In order to understand

More information

What place for mathematicians in plasma physics

What place for mathematicians in plasma physics What place for mathematicians in plasma physics Eric Sonnendrücker IRMA Université Louis Pasteur, Strasbourg projet CALVI INRIA Nancy Grand Est 15-19 September 2008 Eric Sonnendrücker (U. Strasbourg) Math

More information

MIT (Spring 2014)

MIT (Spring 2014) 18.311 MIT (Spring 014) Rodolfo R. Rosales May 6, 014. Problem Set # 08. Due: Last day of lectures. IMPORTANT: Turn in the regular and the special problems stapled in two SEPARATE packages. Print your

More information

Modeling of planar plasma diode

Modeling of planar plasma diode International Letters of Chemistry, Physics and Astronomy Online: 2013-05-03 ISSN: 2299-3843, Vol. 13, pp 220-242 doi:10.18052/www.scipress.com/ilcpa.13.220 2013 SciPress Ltd., Switzerland Modeling of

More information