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

Size: px
Start display at page:

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

Transcription

1 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 tools Explicit PIC codes Lorentz boost Quasi-static approximation Hybrid methods 1

2 Laser technology and new physics Physics of vacuum, ee λ ~ mc C izest, ZetaWatt Laser Intensity, W/cm Ultra-relativistic optics, ea>m p c Relativistic plasmas, ea>mc Plasma physics Atomic physics CPA technology e Field ionization: E = a B ELI, ExaWatt 11/18/014 pukhov@tp1.uni-duesseldorf.de 3 Important relativistic laser-plasma parameters ea a = mc Dimensionless laser amplitude relativistic when a 1 Iλ = W µm /cm ω m 4πe 0 Critical plasma density N c = ~ 10 1 cm -3 S-number S = N an c Gordienko & Pukhov Phys. Plasmas 1, (005) pukhov@tp1.uni-duesseldorf.de 4

3 A. P u kho v, J. P la sm a Ph ysi cs, vol. 61, p a rt 3, p. 45 (1999). Virtual Laser Plasma Lab A. Pukhov, J. Plasma Phys. 61, 45 (1999) Plasma or neutral gas Gas of an arbitrary element can be used. The code VLPL is written in C++, object oriented, parallelized using MPI for Massively Parallel performance 10 9 particles and 10 8 cells can be treated Advanced physics & numerics Fields 1 E 4π B = + j c t c 1 B E = c t Particles dp = qe + dt γ = 1+ p q cγ p B ( mc) Inelastic processes Radiation damping QED effects hybrid hydro model quasi-static approximation 11/18/014 pukhov@tp1.uni-duesseldorf.de 5 The standard PIC time step cycle Deposit j and ρ Advance fields Particles push pukhov@tp1.uni-duesseldorf.de 6 3

4 Equations to solve in full electromagnetic codes Ampere s law Faraday s law Poisson s eq. No magnetic dipoles 1 E 4π = B j c t c 1 B = E c t E = 4πρ B = 0 } Dynamic equations } Static equations pukhov@tp1.uni-duesseldorf.de 7 Charge continuity and locality of the equations Continuity Eq. Ampere s law Poisson s eq. No magnetic dipoles ρ + j = 0 t 1 E 4π = B j c t c E = 4πρ B = 0 } } Local Global equations initial conditions pukhov@tp1.uni-duesseldorf.de 8 4

5 Locality of the equations Only particles within the radius of cτ communicate to each other at every time step τ. This allows for efficient parallelization using domain decomposition Distribution function and kinetic equation N-particles distribution function: F t, r,p,..., r, p ) N ( 1 1 N N Nearly ideal plasma: single particle distribution function: f ( t, r, p) f ( t, r,p) p + t mγ r q p f ( t, r,p) + E + B γ mc γ How to solve this equation? p f ( t, r,p) = St pukhov@tp1.uni-duesseldorf.de 10 5

6 Eulerian approach, FDTD Vlasov codes Very inefficient: a lot of empty phase space has to be processed. However, temperature effects may be described more carefully. Low noise. May be subject to numerical diffusion pukhov@tp1.uni-duesseldorf.de 11 Finite elements approach, integrating along characteristics Characteristics of the Vlasov Eq. coincide with the equations of motion Thus, we just push the numerical macroparticles in self-consistent electromagnetic fields dp p = q E B F dt + mc γ + dr p = dt mγ st pukhov@tp1.uni-duesseldorf.de 1 6

7 Sampling phase space: numerical macroparticles Computationally efficient: only filled parts of phase space have to be processed. However, temperature effects are poorly described, or require very many particles. Noisy as N 1/ pukhov@tp1.uni-duesseldorf.de 13 Maxwell solver: Yee lattice The conservative scheme pukhov@tp1.uni-duesseldorf.de 14 7

8 Yee lattice and the continuity equation The Yee solver conserves div E and rot E. In Coulomb gauge, e.g.: 1 A E = E + E = ϕ ; E = ϕ; c t However, we don t solve the Poisson Eq. Rather, we solve 1 E 4π = B j c t c We must define the currents correctly to satisfy the continuity Eq ϕ = 4πρ ρ + j = 0 t pukhov@tp1.uni-duesseldorf.de 15 Numerical macro-particles We define the charge density at the centers of the grid cells ρ ( r ) ρ ρ i+ 1/. j+ 1/, k + 1/ = Wn S ri + 1/, j+ 1/, k + 1/ n The macro-particles may have arbitrary shapes S. The most common shapes are bricks y x S S ρ ρ i ρ ρ ρ ( r) = S ( x) S ( y) S ( z) ( r ) i = x n y ri, z ri < 1 i i pukhov@tp1.uni-duesseldorf.de 16 8

9 Pushing macro-particles in a cell We assume the second order numerical scheme. Thus, the particle trajectory within the time step τ is a straight line. δy δx Jτ = = Ω Ω dω dω τ 0 VW r+ r r W ρ ρ S S ρ ρ dt ( r r) i+ 1/, j+ 1/, k + 1/ dr pukhov@tp1.uni-duesseldorf.de 17 Villacenor, Buneman CPC 69, 306 (199) Pushing macro-particles in a cell J J J For the simple brick shape, the equations are: r ρ aα = 1 = δxw a a + b x i, j+ 1/, k + 1/ y i+ 1/, j, k + 1/ z i+ 1/, j+ 1/, k = δyw = δzw ρ ρ ( ) y ( a a + b ) x ( a a + b ) Leap-frog field pusher: E n+ 1 x = E z z y n yz xz xy + cτ B n+ 1/ b αβ = α, β = 4πτJ 1 1 δx δx α α { x, y, z} n+ 1/ β α α pukhov@tp1.uni-duesseldorf.de 18 9

10 Pushing macro-particles across cells In its motion within one single time step, the particle can cross several cells. The algorithm must handle all these cases. δy δx Interpolating fields to the particle positions One can interpolate the fields to the centers for the cells first and then interpolate them to the particle center in the same way as one deposits charges Ey E x E x Ey This scheme conserves momentum but not energy pukhov@tp1.uni-duesseldorf.de 0 10

11 Interpolating fields to the particle positions Alternatively, one can interpolate the electric fields in the same way as one deposits currents Ey E x E x Ey This scheme conserves energy, but not momentum When the particle crosses the cell boundaries, all conservations fail pukhov@tp1.uni-duesseldorf.de 1 Energy (in-)conservation in PIC The total energy: 1 E = mnc ( γ 1) + ( E + B ) n 8π V dv Debye length resolved: h=0.5r D Cold plasma: h=10-3 r D pukhov@tp1.uni-duesseldorf.de 11

12 Numerical dispersion in the Yee Maxwell solver Numerical waves do not propagate with the speed of light. Even in vacuum. The standard Yee dispersion relation is: sin τ ωτ ˆ p = ω sin h kxh 1 + sin h 1 + sin h 1 x y y x 1 ˆ p The stability condition is: > ω τ 4 h h h y k h x y z z kzh z pukhov@tp1.uni-duesseldorf.de 3 Numerical dispersion in the Yee Maxwell solver ω cτ = 0.99h cτ = 0.01h Numerical frequency is lower than the real one this leads to lower phase velocity k pukhov@tp1.uni-duesseldorf.de 4 1

13 Numerical dispersion in the Yee Maxwell solver ω cτ = 0.01h cτ = 0.99h Waves with the shortest wavelengths are very slow! Small time steps lead to a bad dispersion pukhov@tp1.uni-duesseldorf.de 5 k Implementation of a PIC code Single processor optimization The central problem of a PIC code: particles must interact with the array of cells pukhov@tp1.uni-duesseldorf.de 6 13

14 Implementation of a PIC code Single processor optimization The linked list of particles with the bases in the cells help to optimize the cache and memory usage pukhov@tp1.uni-duesseldorf.de 7 Implementation of a PIC code Parallelization: domain decomposition pukhov@tp1.uni-duesseldorf.de 8 14

15 Implementation of a PIC code Parallelization: domain decomposition Algorithm locality: only guard cells must communicate between processors. No global communications pukhov@tp1.uni-duesseldorf.de 9 Possibility for load balancing The adaptive partitioning according to the number of particles per processor pukhov@tp1.uni-duesseldorf.de 30 15

16 PIC codes for plasma-based acceleration Bubble regime A.Pukhov & J.Meyer-ter-Vehn, Appl. Phys. B, 74, p.355 (00) The multi-scale problem The plasma acceleration has several very disparate scales 1. Small scale: laser wavelength λ or plasma wavelength λ p. Medium scale: driver length 3. Large scale: acceleration length L A = λ, λ p pukhov@tp1.uni-duesseldorf.de 3 16

17 Energy gain and simulation time Energy gain and simulation time

18 Energy gain and simulation time Energy gain and simulation time

19 Energy gain and simulation time Numerical Cerenkov Instability

20 Numerical Cerenkov Instability Numerical Cerenkov Instability

21 Numerical Cerenkov Instability persists even for dispersion-free solvers Numerical Cerenkov Instability persists even for dispersion-free solvers

22 Numerical Cerenkov Instability persists even for dispersion-free solvers Numerical Cerenkov Instability persists even for dispersion-free solvers

23 Numerical Cerenkov Instability is mitigated by filtering A Pukhov et al. 014 preprint arxiv: , accepted in PRL Electron acceleration in a channel: towards high quality acceleration A channel helps to moderate the accelerating field and adjust the laser depletion length A region of constant accelerating field appears where monoenergetic acceleration is possible pukhov@tp1.uni-duesseldorf.de 46 3

24 A Pukhov et al. 014 preprint arxiv: , accepted in PRL Electron acceleration in a channel: towards high quality acceleration 3D PIC simulation in a Lorentz-boosted frame Energy gain: 4 GeV Laser pulse: 140 J, 16 fs Plasma: 3x /cm 3. Acceleration distance: 100 cm pukhov@tp1.uni-duesseldorf.de 47 A Pukhov et al. 014 preprint arxiv: , accepted in PRL Electron acceleration in a channel: Field Reversed Bubble The transverse electric field reverses Uniform plasma Deep channel pukhov@tp1.uni-duesseldorf.de 48 4

25 Electron acceleration in a channel: towards high quality acceleration pukhov@tp1.uni-duesseldorf.de 49 Analytical methods to bridge the scales gap First-principles PIC codes are universal but computationally expensive. Efficient analytical methods exist to handle the multi-scale problems. 1. Envelope approximation for the laser removes the laser wavelength λ scale. Quasi-static approximation explicitly separates the fast coordinate ζ=z-ct and the slow evolution time τ=t Any approximation means some physics is neglected though pukhov@tp1.uni-duesseldorf.de 50 5

26 Envelope approximation for the laser When the laser pulse amplitude changes slowly on the laser wavelength scale, the envelope approximation can be used ik c t ς A L 4πq = mc n γ A L This approximation excludes, e.g. sharp fronts of laser pulses pukhov@tp1.uni-duesseldorf.de 51 Particle motion in ponderomotive approximation The laser pulse acts on particles then via its ponderomotive force only dp p q = q dt E + B mc γ γm A L This approximation works only when the particle excursion length is smaller than the laser pulse focal spot pukhov@tp1.uni-duesseldorf.de 5 6

27 D.F.Gordon et al. IEEE TPS 8, 14 (000) Ponderomotive guiding center PIC Fields are separated in low frequency and high frequency components. The LF is treated by standard PIC, the HF is treated in envelope approximation Deposit j and ρ Advance LF fields Lorentz push + Calculate <nq /γm> Advance HF fields Ponderomotive push pukhov@tp1.uni-duesseldorf.de 53 Quasi-static approximation E z z We separate the fast coordinate ζ=z-ct and the slow evolution time τ=t. t << ζ It is assumed that the driver does not change during the time it passes its own length pukhov@tp1.uni-duesseldorf.de 54 7

28 Quasi-static approximation Integral of motion Particles have an additional integral of motion in the QS approximation: H = γ p + qψ =1 z Where the wake potential is and we use the axial gauge so that ψ = ϕ A z ϕ A =ψ / = z dς 1 qψ = vz 1 = dt γ pukhov@tp1.uni-duesseldorf.de 55 Quasi-static approximation Field equations We change variables to the fast coordinate ζ=z-ct and the slow evolution time τ=t in Maxweel Eqs.: and neglect the time derivatives in (1) and (), so that t = ξ τ B = j + E E = B B = 0 E = ρ () (3) (4) Thus, the quasi-static approximation cannot treat radiation anymore! t t (1) pukhov@tp1.uni-duesseldorf.de 56 8

29 Quasi-static approximation Field equations It is possible to write the quasi-static equations on the fields only (K.V.Lotov 007): E = ρ j E = j B = j Alternatively, one can use potentials. In all cases, the quasi-static equations are not local anymore in the transverse planes. This is the result of removing the wave behavior. Instead of the wave equation, we obtain a set of elliptic equations on the fields pukhov@tp1.uni-duesseldorf.de 57 Pushing particles In quasi-static codes, one seeds a single layer of particles at the leading edge of the simulation box and pushes them through the driver pukhov@tp1.uni-duesseldorf.de 58 9

30 30 Quasi-static approximation Equations of motion We push the particles along the ζ coordinate ( ) ς ς ς d d v dt d d d dt d z p p p 1 = = so that ( ) ς ς ς d d v dt d d d dt d z r r r v 1 = = = + = 1 1 L z A q mc q v d d γ γ ς B p E p 11/18/014 pukhov@tp1.uni-duesseldorf.de 60

31 Compare quasi-static qs-vlpl3d vs explicit VLPL3D Ne E pukhov@tp1.uni-duesseldorf.de 61 Example Compare quasi-static VLPL3D vs explicit E B pukhov@tp1.uni-duesseldorf.de 6 31

32 Efficiency of the PIC codes Explicit PIC effort (number of operations): N op 0 / c, hx << λ0 = N τ << λ, h, h << λ y τ N z x N y N z p Lorentz-boost: relativistic gain up to γ Quasi-static codes gain in performance as τ << λ / cλ, 0 h << λ, h, h << λ p ( λ / λ ) 3 p 0 x p y z p pukhov@tp1.uni-duesseldorf.de 63 Hybrid PIC/hydro codes The kinetic PIC description is rather expensive Alternative: Computational Fluid Dynamics (CFD) Euler s equations, Navier-Stokes equations or variants are solved on a grid Very established field of research - large number of solvers available Faster and more efficient Less physics: cannot e.g. model wave breaking pukhov@tp1.uni-duesseldorf.de 64 3

33 Hybrid PIC/hydro codes Tuckmantel et al., IEEE TPS 38 (01) Hybrid PIC/hydro codes

34 Tuckmantel et al., IEEE TPS 38 (01) Hybrid PIC/hydro codes Hybrid PIC/hydro codes

35 Hybrid PIC/hydro codes Hybrid PIC/hydro codes T Tückmantel, A Pukhov Journal pukhov@tp1.uni-duesseldorf.de of Computational Physics 69, (014) 70 35

36 Hybrid PIC/hydro codes T Tückmantel, A Pukhov Journal of Computational Physics 69, (014) Hybrid PIC/hydro codes pukhov@tp1.uni-duesseldorf.de 7 36

37 Hybrid PIC/hydro codes T Tückmantel, A Pukhov Journal of Computational Physics 69, (014) Hybrid PIC/hydro codes pukhov@tp1.uni-duesseldorf.de 74 T Tückmantel, A Pukhov Journal of Computational Physics 69, (014) 37

38 Hybrid PIC/hydro codes T Tückmantel, A Pukhov Journal of Computational Physics 69, (014) Hybrid PIC/hydro codes pukhov@tp1.uni-duesseldorf.de 76 38

39 Summary PIC codes are the established tools for plasma simulation Lorentz boost can bridge the gap of scales in plasma acceleration still keeping the first principles. Unfortunately, it is subject to numerical instabilities. Quasi-static codes use analytic approaches to separate the scales Hybrid hydro-pic codes help to improve the numerical dispersion and stability 11/18/

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

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

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

Stable Propagating Waves and Wake Fields in Relativistic Electromagnetic Plasma

Stable Propagating Waves and Wake Fields in Relativistic Electromagnetic Plasma Commun. Theor. Phys. (Beijing, China) 49 (2008) pp. 753 758 c Chinese Physical Society Vol. 49, No. 3, March 15, 2008 Stable Propagating Waves and Wake Fields in Relativistic Electromagnetic Plasma XIE

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

Simulating experiments for ultra-intense laser-vacuum interaction

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

More information

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

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

The Bubble regime of laser-plasma acceleration: monoenergetic electrons and the scalability.

The Bubble regime of laser-plasma acceleration: monoenergetic electrons and the scalability. The Bubble regime of laser-plasma acceleration: monoenergetic electrons and the scalability. A. Pukhov, S. Gordienko, S. Kiselev, and I. Kostyukov Institute for theoretical physics I University of Duesseldorf,

More information

Relativistic laser beam propagation and critical density increase in a plasma

Relativistic laser beam propagation and critical density increase in a plasma Relativistic laser beam propagation and critical density increase in a plasma Su-Ming Weng Theoretical Quantum Electronics (TQE), Technische Universität Darmstadt, Germany Joint work with Prof. Peter Mulser

More information

Title Surface Interaction under Oblique Intense. Author(s) Ruhl, H.; Sentoku, Y.; Mima, K.; Ta. Citation Physical Review Letters. 82(4) P.

Title Surface Interaction under Oblique Intense. Author(s) Ruhl, H.; Sentoku, Y.; Mima, K.; Ta. Citation Physical Review Letters. 82(4) P. Title Collimated Electron Jets by Surface Interaction under Oblique Intense I Author(s) Ruhl, H.; Sentoku, Y.; Mima, K.; Ta Citation Physical Review Letters. 82(4) P.74 Issue 1999-01-25 Date Text Version

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

Laser trigged proton acceleration from ultrathin foil

Laser trigged proton acceleration from ultrathin foil Laser trigged proton acceleration from ultrathin foil A.V. Brantov 1, V. Yu. Bychenkov 1, D. V. Romanov 2, A. Maksimchuk 3 1 P. N. Lebedev Physics Institute RAS, Moscow 119991, Russia 2 All-Russia Research

More information

Fast proton bunch generation in the interaction of ultraintense laser pulses with high-density plasmas

Fast proton bunch generation in the interaction of ultraintense laser pulses with high-density plasmas Fast proton bunch generation in the interaction of ultraintense laser pulses with high-density plasmas T.Okada, Y.Mikado and A.Abudurexiti Tokyo University of Agriculture and Technology, Tokyo -5, Japan

More information

arxiv: v1 [physics.plasm-ph] 30 Jul 2011

arxiv: v1 [physics.plasm-ph] 30 Jul 2011 Phase velocity and particle injection in a self-modulated proton-driven plasma wakefield accelerator A. Pukhov 1, N. Kumar 1, T. Tückmantel 1, A. Upadhyay 1, K. Lotov 2, P. Muggli 3, V. Khudik 4, C. Siemon

More information

Part III. Interaction with Single Electrons - Plane Wave Orbits

Part III. Interaction with Single Electrons - Plane Wave Orbits Part III - Orbits 52 / 115 3 Motion of an Electron in an Electromagnetic 53 / 115 Single electron motion in EM plane wave Electron momentum in electromagnetic wave with fields E and B given by Lorentz

More information

Introduction to Plasma Physics

Introduction to Plasma Physics Mitglied der Helmholtz-Gemeinschaft Introduction to Plasma Physics CERN School on Plasma Wave Acceleration 24-29 November 2014 Paul Gibbon Outline Lecture 1: Introduction Definitions and Concepts Lecture

More information

plasma optics Amplification of light pulses: non-ionised media

plasma optics Amplification of light pulses: non-ionised media Amplification of light pulses: non-ionised media since invention of laser: constant push towards increasing focused intensity of the light pulses Chirped pulse amplification D. Strickland, G. Mourou, Optics

More information

(a) Write down the total Hamiltonian of this system, including the spin degree of freedom of the electron, but neglecting spin-orbit interactions.

(a) Write down the total Hamiltonian of this system, including the spin degree of freedom of the electron, but neglecting spin-orbit interactions. 1. Quantum Mechanics (Spring 2007) Consider a hydrogen atom in a weak uniform magnetic field B = Bê z. (a) Write down the total Hamiltonian of this system, including the spin degree of freedom of the electron,

More information

A.G.R.Thomas November Mono-energetic beams of relativistic electrons from intense laser plasma interactions

A.G.R.Thomas November Mono-energetic beams of relativistic electrons from intense laser plasma interactions A.G.R.Thomas November 2004 Mono-energetic beams of relativistic electrons from intense laser plasma interactions Contents Background Experiments on Astra 2003-2004 Production of narrow energy spread electron

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.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

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

Nonlinear Optics (WiSe 2015/16) Lecture 12: January 15, 2016

Nonlinear Optics (WiSe 2015/16) Lecture 12: January 15, 2016 Nonlinear Optics (WiSe 2015/16) Lecture 12: January 15, 2016 12 High Harmonic Generation 12.1 Atomic units 12.2 The three step model 12.2.1 Ionization 12.2.2 Propagation 12.2.3 Recombination 12.3 Attosecond

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

Computer Physics Communications

Computer Physics Communications Computer Physics Communications 180 (2009) 651 655 Contents lists available at ScienceDirect Computer Physics Communications www.elsevier.com/locate/cpc Two-dimensional simulations of the amplification

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

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

Introduction to intense laser-matter interaction

Introduction to intense laser-matter interaction Pohang, 22 Aug. 2013 Introduction to intense laser-matter interaction Chul Min Kim Advanced Photonics Research Institute (APRI), Gwangju Institute of Science and Technology (GIST) & Center for Relativistic

More information

Recent developments in the Dutch Laser Wakefield Accelerators program at the University of Twente: New external bunch injection scheme.

Recent developments in the Dutch Laser Wakefield Accelerators program at the University of Twente: New external bunch injection scheme. Recent developments in the Dutch Laser Wakefield Accelerators program at the University of Twente: New external bunch injection scheme. A.G. Khachatryan, F.A. van Goor, J.W.J. Verschuur and K.-J. Boller

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

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

Calculation of wakefields for plasma-wakefield accelerators

Calculation of wakefields for plasma-wakefield accelerators 1 Calculation of wakefields for plasma-wakefield accelerators G. Stupakov, SLAC ICFA mini-workshop on Impedances and Beam Instabilities in Particle Accelerators 18-22 September 2017 2 Introduction to PWFA

More information

Modeling of Space Charge Effects and Coherent Synchrotron Radiation in Bunch Compression Systems. Martin Dohlus DESY, Hamburg

Modeling of Space Charge Effects and Coherent Synchrotron Radiation in Bunch Compression Systems. Martin Dohlus DESY, Hamburg Modeling of Space Charge Effects and Coherent Synchrotron Radiation in Bunch Compression Systems Martin Dohlus DESY, Hamburg SC and CSR effects are crucial for design & simulation of BC systems CSR and

More information

Γ f Σ z Z R

Γ f Σ z Z R SLACPUB866 September Ponderomotive Laser Acceleration and Focusing in Vacuum for Generation of Attosecond Electron Bunches Λ G. V. Stupakov Stanford Linear Accelerator Center Stanford University, Stanford,

More information

arxiv:physics/ v1 [physics.plasm-ph] 16 Jan 2007

arxiv:physics/ v1 [physics.plasm-ph] 16 Jan 2007 The Effect of Laser Focusing Conditions on Propagation and Monoenergetic Electron Production in Laser Wakefield Accelerators arxiv:physics/0701186v1 [physics.plasm-ph] 16 Jan 2007 A. G. R. Thomas 1, Z.

More information

1. (16) A point charge e moves with velocity v(t) on a trajectory r(t), where t is the time in some lab frame.

1. (16) A point charge e moves with velocity v(t) on a trajectory r(t), where t is the time in some lab frame. Electrodynamics II Exam 3. Part A (120 pts.) Closed Book Radiation from Acceleration Name KSU 2016/05/10 14:00-15:50 Instructions: Some small derivations here, state your responses clearly, define your

More information

Wakefields and beam hosing instability in plasma wake acceleration (PWFA)

Wakefields and beam hosing instability in plasma wake acceleration (PWFA) 1 Wakefields and beam hosing instability in plasma wake acceleration (PWFA) G. Stupakov, SLAC DESY/University of Hamburg accelerator physics seminar 21 November 2017 Introduction to PWFA Plasma wake excited

More information

Electron acceleration by coherent laser pulse echelons in periodic plasma structures

Electron acceleration by coherent laser pulse echelons in periodic plasma structures Electron acceleration by coherent laser pulse echelons in periodic plasma structures A. Pukhov I. Kostyukov, T. Tückmantel, Ph. Luu-Thanh Uni Dusseldorf, Germany Uni Nizhni Novgorod, Russia A. Pukhov et

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

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

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

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

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

Intense laser pulse amplification using Raman backscatter in plasma channels

Intense laser pulse amplification using Raman backscatter in plasma channels 15 April 2002 Physics Letters A 296 (2002) 109 116 www.elsevier.com/locate/pla Intense laser pulse amplification using Raman backscatter in plasma channels P. Mardahl a,,h.j.lee a,g.penn a,j.s.wurtele

More information

Electromagnetically Induced Flows in Water

Electromagnetically Induced Flows in Water Electromagnetically Induced Flows in Water Michiel de Reus 8 maart 213 () Electromagnetically Induced Flows 1 / 56 Outline 1 Introduction 2 Maxwell equations Complex Maxwell equations 3 Gaussian sources

More information

Plasma Wakefield Acceleration of. Positron Bunches. Jorge Vieira

Plasma Wakefield Acceleration of. Positron Bunches. Jorge Vieira GoLP/IPFN Instituto Superior Técnico Plasma Wakefield Acceleration of Jorge Vieira! Instituto de Plasmas e Fusão Nuclear Instituto Superior Técnico Lisbon, Portugal http://epp.ist.utl.pt[/jorgevieira]

More information

Electron Acceleration in Laser Plasma

Electron Acceleration in Laser Plasma Electron Acceleration in Laser Plasma Vojt ech Horn y IPP AV CR 4th December 2014, Praha Vojt ech Horn y (IPP AV CR) Electron Acceleration in Laser Plasma 4th December 2014, Praha 1 / 34 List of Contents

More information

Introduction to plasma wakefield acceleration. Stuart Mangles The John Adams Institute for Accelerator Science Imperial College London

Introduction to plasma wakefield acceleration. Stuart Mangles The John Adams Institute for Accelerator Science Imperial College London Introduction to plasma wakefield acceleration Stuart Mangles The John Adams Institute for Accelerator Science Imperial College London plasma as an accelerator ~ 1 m; ~ 40 MV/m ~ 50 µm; ~ 100 GV/m a plasma

More information

Integrated Modeling of Fast Ignition Experiments

Integrated Modeling of Fast Ignition Experiments Integrated Modeling of Fast Ignition Experiments Presented to: 9th International Fast Ignition Workshop Cambridge, MA November 3-5, 2006 R. P. J. Town AX-Division Lawrence Livermore National Laboratory

More information

Physics of ion beam pulse neutralization by background plasma

Physics of ion beam pulse neutralization by background plasma Physics of ion beam pulse neutralization by background plasma I.D. Kaganovich, A. B. Sefkow, E. A. Startsev, R. C. Davidson Princeton Plasma Physics Laboratory, USA D R. Welch Voss Scientific, USA Effects

More information

M o n o e n e r g e t i c A c c e l e r a t i o n o f E l e c t r o n s b y L a s e r - D r i v e n P l a s m a W a v e

M o n o e n e r g e t i c A c c e l e r a t i o n o f E l e c t r o n s b y L a s e r - D r i v e n P l a s m a W a v e USj-WS on HIF & HEDP at Utsunomiya 29 Sep,. 2005 M o n o e n e r g e t i c A c c e l e r a t i o n o f E l e c t r o n s b y L a s e r - D r i v e n P l a s m a W a v e Kazuyoshi KOYAMA, Takayuki WATANABE

More information

Progress in Vlasov-Fokker- Planck simulations of laserplasma

Progress in Vlasov-Fokker- Planck simulations of laserplasma Progress in Vlasov-Fokker- Planck simulations of laserplasma interactions C. P. Ridgers, M. W. Sherlock, R. J. Kingham, A.Thomas, R. Evans Imperial College London Outline Part 1 simulations of long-pulse

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

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

Generation of a single attosecond pulse from an overdense plasma surface driven by a laser pulse with time-dependent polarization

Generation of a single attosecond pulse from an overdense plasma surface driven by a laser pulse with time-dependent polarization Generation of a single attosecond pulse from an overdense plasma surface driven by a laser pulse with time-dependent polarization Luo Mu-Hua( ) and Zhang Qiu-Ju( ) College of Physics and Electronics, Shandong

More information

Exploring Born-Infeld electrodynamics using plasmas

Exploring Born-Infeld electrodynamics using plasmas Exploring Born-Infeld electrodynamics using plasmas David A Burton & Haibao Wen (with Raoul MGM Trines 1, Adam Noble 2, Timothy J Walton) Department of Physics, Lancaster University and the Cockcroft Institute

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

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

Simulations of the plasma dynamics in high-current ion diodes

Simulations of the plasma dynamics in high-current ion diodes Nuclear Instruments and Methods in Physics Research A 415 (1998) 473 477 Simulations of the plasma dynamics in high-current ion diodes O. Boine-Frankenheim *, T.D. Pointon, T.A. Mehlhorn Gesellschaft fu(

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

Laser-plasma particle accelerators. Zulfikar Najmudin

Laser-plasma particle accelerators. Zulfikar Najmudin Laserplasma particle accelerators Zulfikar Najmudin Vulcan: High Power Laser High intensity lasers 10 15 The evolution of Power of small diameter laser systems State of art e.g. Vulcan Petawatt, 400 J

More information

E & M Qualifier. January 11, To insure that the your work is graded correctly you MUST:

E & M Qualifier. January 11, To insure that the your work is graded correctly you MUST: E & M Qualifier 1 January 11, 2017 To insure that the your work is graded correctly you MUST: 1. use only the blank answer paper provided, 2. use only the reference material supplied (Schaum s Guides),

More information

Interaction of an Intense Electromagnetic Pulse with a Plasma

Interaction of an Intense Electromagnetic Pulse with a Plasma Interaction of an Intense Electromagnetic Pulse with a Plasma S. Poornakala Thesis Supervisor Prof. P. K. Kaw Research collaborators Prof. A. Sen & Dr.Amita Das. v B Force is negligible Electrons are non-relativistic

More information

Simulations of high intensity laserplasma

Simulations of high intensity laserplasma Simulations of high intensity laserplasma interactions Generating radiation of extreme intensity Gustav Mårtensson Master s Thesis in Applied Physics Department of Applied Physics Division of Condensed

More information

[variable] = units (or dimension) of variable.

[variable] = units (or dimension) of variable. Dimensional Analysis Zoe Wyatt wyatt.zoe@gmail.com with help from Emanuel Malek Understanding units usually makes physics much easier to understand. It also gives a good method of checking if an answer

More information

Simulations of the Microbunching Instability in FEL Beam Delivery Systems

Simulations of the Microbunching Instability in FEL Beam Delivery Systems Simulations of the Microbunching Instability in FEL Beam Delivery Systems Ilya Pogorelov Tech-X Corporation Workshop on High Average Power & High Brightness Beams UCLA, January 2009 Outline The setting:

More information

CERN Accelerator School. Intermediate Accelerator Physics Course Chios, Greece, September Low Emittance Rings

CERN Accelerator School. Intermediate Accelerator Physics Course Chios, Greece, September Low Emittance Rings CERN Accelerator School Intermediate Accelerator Physics Course Chios, Greece, September 2011 Low Emittance Rings Part 1: Beam Dynamics with Synchrotron Radiation Andy Wolski The Cockcroft Institute, and

More information

A Three-Fluid Approach to Model Coupling of Solar Wind-Magnetosphere-Ionosphere- Thermosphere

A Three-Fluid Approach to Model Coupling of Solar Wind-Magnetosphere-Ionosphere- Thermosphere A Three-Fluid Approach to Model Coupling of Solar Wind-Magnetosphere-Ionosphere- Thermosphere P. Song Center for Atmospheric Research University of Massachusetts Lowell V. M. Vasyliūnas Max-Planck-Institut

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

Weibel instability and filamentary structures of a relativistic electron beam in plasma

Weibel instability and filamentary structures of a relativistic electron beam in plasma Mitglied der Helmholtz-Gemeinschaft 7 th Direct Drive and Fast Ignition Workshop Prague, 3-6 May, 009 Weibel instability and filamentary structures of a relativistic electron beam in plasma Anupam Karmakar

More information

Electromagnetic Waves Retarded potentials 2. Energy and the Poynting vector 3. Wave equations for E and B 4. Plane EM waves in free space

Electromagnetic Waves Retarded potentials 2. Energy and the Poynting vector 3. Wave equations for E and B 4. Plane EM waves in free space Electromagnetic Waves 1 1. Retarded potentials 2. Energy and the Poynting vector 3. Wave equations for E and B 4. Plane EM waves in free space 1 Retarded Potentials For volume charge & current = 1 4πε

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

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

Relativistic Strong Field Ionization and Compton Harmonics Generation

Relativistic Strong Field Ionization and Compton Harmonics Generation Relativistic Strong Field Ionization and Compton Harmonics Generation Farhad Faisal Fakultaet fuer Physik Universitiaet Bielefeld Germany Collaborators: G. Schlegel, U. Schwengelbeck, Sujata Bhattacharyya,

More information

Scattering of Electromagnetic Radiation. References:

Scattering of Electromagnetic Radiation. References: Scattering of Electromagnetic Radiation References: Plasma Diagnostics: Chapter by Kunze Methods of experimental physics, 9a, chapter by Alan Desilva and George Goldenbaum, Edited by Loveberg and Griem.

More information

Plasma Processes. m v = ee. (2)

Plasma Processes. m v = ee. (2) Plasma Processes In the preceding few lectures, we ve focused on specific microphysical processes. In doing so, we have ignored the effect of other matter. In fact, we ve implicitly or explicitly assumed

More information

BEAM INSTABILITIES IN LINEAR MACHINES 1.

BEAM INSTABILITIES IN LINEAR MACHINES 1. BEAM INSTABILITIES IN LINEAR MACHINES 1 Massimo.Ferrario@LNF.INFN.IT CERN 4 November 2015 SELF FIELDS AND WAKE FIELDS The realm of collecdve effects Direct self fields Image self fields Space Charge Wake

More information

Faraday Transport in a Curved Space-Time

Faraday Transport in a Curved Space-Time Commun. math. Phys. 38, 103 110 (1974) by Springer-Verlag 1974 Faraday Transport in a Curved Space-Time J. Madore Laboratoire de Physique Theorique, Institut Henri Poincare, Paris, France Received October

More information

Suppression of Radiation Excitation in Focusing Environment * Abstract

Suppression of Radiation Excitation in Focusing Environment * Abstract SLAC PUB 7369 December 996 Suppression of Radiation Excitation in Focusing Environment * Zhirong Huang and Ronald D. Ruth Stanford Linear Accelerator Center Stanford University Stanford, CA 94309 Abstract

More information

Lecture 21 Reminder/Introduction to Wave Optics

Lecture 21 Reminder/Introduction to Wave Optics Lecture 1 Reminder/Introduction to Wave Optics Program: 1. Maxwell s Equations.. Magnetic induction and electric displacement. 3. Origins of the electric permittivity and magnetic permeability. 4. Wave

More information

Physics 214 Final Exam Solutions Winter 2017

Physics 214 Final Exam Solutions Winter 2017 Physics 14 Final Exam Solutions Winter 017 1 An electron of charge e and mass m moves in a plane perpendicular to a uniform magnetic field B If the energy loss by radiation is neglected, the orbit is a

More information

Part VIII. Interaction with Solids

Part VIII. Interaction with Solids I with Part VIII I with Solids 214 / 273 vs. long pulse is I with Traditional i physics (ICF ns lasers): heating and creation of long scale-length plasmas Laser reflected at critical density surface Fast

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

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

Unruh effect & Schwinger mechanism in strong lasers?

Unruh effect & Schwinger mechanism in strong lasers? Unruh effect & Schwinger mechanism in strong lasers? Ralf Schützhold Fachbereich Physik Universität Duisburg-Essen Unruh effect & Schwinger mechanism in strong lasers? p.1/14 Unruh Effect Uniformly accelerated

More information

Relativistic Electron Heating in Focused Multimode Laser Fields with Stochastic Phase Purturbations

Relativistic Electron Heating in Focused Multimode Laser Fields with Stochastic Phase Purturbations 1 Relativistic Electron Heating in Focused Multimode Laser Fields with Stochastic Phase Purturbations Yu.A.Mikhailov, L.A.Nikitina, G.V.Sklizkov, A.N.Starodub, M.A.Zhurovich P.N.Lebedev Physical Institute,

More information

Plasmas as fluids. S.M.Lea. January 2007

Plasmas as fluids. S.M.Lea. January 2007 Plasmas as fluids S.M.Lea January 2007 So far we have considered a plasma as a set of non intereacting particles, each following its own path in the electric and magnetic fields. Now we want to consider

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

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

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

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

An Introduction to Plasma Accelerators

An Introduction to Plasma Accelerators An Introduction to Plasma Accelerators Humboldt University Research Seminar > Role of accelerators > Working of plasma accelerators > Self-modulation > PITZ Self-modulation experiment > Application Gaurav

More information

Proton-driven plasma wakefield acceleration

Proton-driven plasma wakefield acceleration Proton-driven plasma wakefield acceleration Konstantin Lotov Budker Institute of Nuclear Physics SB RAS, Novosibirsk, Russia Novosibirsk State University, Novosibirsk, Russia AWAKE Collaboration Motivation

More information

ブラックホール磁気圏での 磁気リコネクションの数値計算 熊本大学 小出眞路 RKKコンピュー 森野了悟 ターサービス(株) BHmag2012,名古屋大学,

ブラックホール磁気圏での 磁気リコネクションの数値計算 熊本大学 小出眞路 RKKコンピュー 森野了悟 ターサービス(株) BHmag2012,名古屋大学, RKK ( ) BHmag2012,, 2012.2.29 Outline Motivation and basis: Magnetic reconnection around astrophysical black holes Standard equations of resistive GRMHD Test calculations of resistive GRMHD A simulation

More information

Multi-GeV electron acceleration using the Texas Petawatt laser

Multi-GeV electron acceleration using the Texas Petawatt laser Multi-GeV electron acceleration using the Texas Petawatt laser X. Wang, D. Du, S. Reed, R. Zgadzaj, P.Dong, N. Fazel, R. Korzekwa, Y.Y. Chang, W. Henderson M. Downer S.A. Yi, S. Kalmykov, E. D'Avignon

More information

Space Charge in Linear Machines

Space Charge in Linear Machines Space Charge in Linear Machines Massimo.Ferrario@LNF.INFN.IT Egham September 6 th 017 Relativistic equation of motion dp dt = F p = γm o v γm o dv dt + m ov dγ dt = F β = v c dγ dt = d dt " a v % m o γ

More information

External Injection in Plasma Accelerators. R. Pompili, S. Li, F. Massimo, L. Volta, J. Yang

External Injection in Plasma Accelerators. R. Pompili, S. Li, F. Massimo, L. Volta, J. Yang External Injection in Plasma Accelerators R. Pompili, S. Li, F. Massimo, L. Volta, J. Yang Why Plasma Accelerators? Conventional RF cavities: 50-100 MV/m due to electrical breakdown Plasma: E>100 GV/m

More information

Particle-in-Cell Simulations of Particle Acceleration. E. A. Startsev and C. J. McKinstrie. Laboratory for Laser Energetics, U.

Particle-in-Cell Simulations of Particle Acceleration. E. A. Startsev and C. J. McKinstrie. Laboratory for Laser Energetics, U. Particle-in-Cell Simulations of Particle Acceleration E. A. Startsev and C. J. McKinstrie Laboratory for Laser Energetics, U. of Rochester Previous analytical calculations suggest that a preaccelerated

More information