Integrated Tokamak Code: TASK

Size: px
Start display at page:

Download "Integrated Tokamak Code: TASK"

Transcription

1 2010/01/18 Integrated Tokamak Code: TASK A. Fukuyama Department of Nuclear Engineering, Kyoto University Acknowledgments M. Honda, H. Nuga, and BPSI working group

2 Outline 1. Integrated Simulation of Fusion Plasmas 2. Integrated Tokamak Modeling Code: TASK 3. Transport Modeling 4. Source Modeling 5. ITER Modeling 6. Summary

3 Integrated Simulation of Toroidal Plasmas Why needed? To predict the behavior of burning plasmas in tokamaks To develop reliable and efficient schemes to control them What is needed? Simulation describing: Whole plasma (core & edge & divertor & wall-plasma) Whole discharge (startup & sustainment & transients events & termination) Reasonable accuracy (validation by experiments) Reasonable computer resources (still limited) How can we do? Gradual increase of understanding and accuracy Organized development of simulation system

4 Simulation of Tokamak Plasmas Broad range of time scale: 100GHz 1000s Broad range of Spatial scale: 10 μm 10m Energetic Ion Confinement Transport Barrier Core Transport MHD Stability Non-Inductive CD LENGTH 1m 1mm Heating LH EC IC MHD Transport NBI Turbulence Turbulent Transport Impurity Transport SOL Transport RF Heating NBI Heating Neutral Transport 1GHz 1MHz TIME 1kHz 1Hz Divertor Plasma Plasma-Wall Int. One simulation code never covers all range. Blanket, Neutronics, Tritium, Material, Heat and Fluid Flow Integrated simulation combining modeling codes interacting each other

5 Integrated Tokamak Simulation

6 Desired Features of Integrated Modeling Code Modular structure: forflexible extension of analyses Core modules (equilibrium, transport, source, stability) Various levels of models (quick, standard, precise, rigorous) New physics models (easier development) Standard module interface: for efficient development-of modules Interface with experimental data: for validating physics models Unified user interface: for user-friendly environment Scalability in parallel processing of time consuming modules High portability Open source of core modules Visualization included

7 Integrated Modeling Activities Japan: BPSI (Burning Plasma Simulation Initiative) Research collaboration among universities, NIFS and JAEA Framework for code integration Physics integration Advanced computing technology EU: ITM-TF (EFDA Task Force: Integrated Transport Modeling) Code Platform Project: code interface, data structure Data Coordination Project: verification and validation Five Integrated Modeling Projects: EQ, MHD, TR, Turb., Source US: FSP (Fusion simulation project) a part of SciDAC Simulation of Wave Interactions with Magnetohydrodynamics (SWIM) Center for Plasma Edge Simulation (CPES) Framework Application for Core-Edge Transport Simulations (FACETS) ITER: IMEG (Integrated Modeling Expert Group)

8 BPSI: Burning Plasma Simulation Initiative Research Collaboration of Universities, NIFS and JAEA Targets of BPSI Framework for collaboration of various plasma simulation codes Physics integration with different time and space scales Advanced technique of computer science All Japan collaboration Integrated code development

9 Integrated Modeling Code: TASK Transport Analysing System for TokamaK Features Core of Integrated Modeling Code in BPSI Modular structure Reference imprementation of standard data set and interface Various Heating and Current Drive Scheme EC, LH, IC, AW, NB High Portability Most of library routines included (except LAPACK, MPI, MDS+) Original graphic libraries (X11, Postscript, OpenGL) Development using CVS (Version control) Open Source: Parallel Processing using MPI Library (partially)

10 Components of the TASK Code Developed since 1992, now in Kyoto University BPSD Data Exchange Standard data set, Program interface EQ 2D Equilibrium Fixed boundary, Toroidal rotation TR 1D Transport Diffusive transport, Transport models TX 1D Transport Dynamic Transport, Rotation and E r FP 3D Fokker-Planck Relativistic, Bounce-averaged WR 3D Ray Tracing EC, LH: Ray tracing, Beam tracing WM 3D Full Wave IC: Antenna excite, Alfvén Eigenmode DP Wave Dispersion Dielectric tensor, Arbitrary f (u) FIT3D NBI Physics Birth, Orbit width, Deposition PL Utilities Interface to BPSD and profile database LIB Libraries Commonlibraries,MTX,MPI GSAF Graphics Original graphic library for Fortran TASK3D: Extension to 3D Helical Plasmas (NIFS and Kyoto U)

11 Original Structure of the TASK code

12 Present Structure of TASK and Related Codes in BPSI

13 Inter-Module Collaboration Interface Role of Module Interface Data exchange between modules: BPSD Standard dataset: Specify set of data Specification of data exchange interface: set/get/load/save Execution control: BPSX Specification of execution control interface: initialize, setup, exec, visualize, terminate Uniform user interface: parameter input, graphic output Role of data exchange interface Keep present status of plasma and device Save into file and load from file Store history of plasma Interface to experimental data base

14 Policies of BPSD Minimum and Sufficient Dataset To minimize the data to be exchanged Mainly profile data Routines to calculate global integrated quantities separately provided Minimum Arguments in Interfaces To maximize flexibility Use derived data type or struct Only one dataset in the arguments of an interface Minimum Interfaces To make modular programming easier Use function overloading

15 Data Exchange Interface: BPSD Standard dataset: Specify data to be stored and exchanged Data structure: Derived type (Fortran95): structured type e.g. Specification of API: Program interface e.g. time plasmaf%time number of grid plasmaf%nrmax number of species plasmaf%nsmax square of grid radius plasmaf%s(nr) plasma density plasmaf%data(nr,ns)%pn plasma temperature plasmaf%data(nr,ns)%pt Set data bpsd set data(plasmaf,ierr) Get data bpsd get data(plasmaf,ierr) Save data bpsd save(ierr) Load data bpsd load(ierr)

16 BPSD Standard Dataset (version 0.6) Category Name EQ TR TX FP WR WM DP Shot data bpsd shot type Device data bpsd device type in in in in 1D equilibrium data bpsd equ1d type out in in in 2D equilibrium data bpsd equ2d type out in in in in 1D metric data bpsd metric1d type out in in in 2D metric data bpsd metric2d type out in in in in Plasma species data bpsd species type in in in in in Fluid plasma data bpsd plasmaf type in out out i/o in Kinetic plasma data bpsd plasmak type out in Transport matrix data bpsd trmatrix type i/o Transport source data bpsd trsource type i/o i/o i/o out out Dielectric tensor data bpsd dielectric type in in out Full wave field data bpsd wavef type in out Ray tracing field data bpsd waver type in out Beam tracing field data bpsd waveb type in out User defined data bpsd 0/1/2ddata type

17 Execution Control Interface BPSX: not yet decided Monolithic integrated code Script-driven element codes MPI-2 driven element codes Example of element codes for TASK/TR TR INIT Initialization (Default value) TR PARM(ID,PSTR) Parameter setup (Namelist input) TR SETUP(T) Profile setup (Spatial profile, Time) TR EXEC(DT) Exec one step (Time step) TR GOUT(PSTR) Plot data (Plot command) TR SAVE Save data in file TR LOAD load data from file TR TERM Termination

18 Equilibrium Analysis Shape of an axisymmetric plasma: poloidal magnetic flux ψ(r, Z) Grad-Shafranov equation R 1 ψ RR R + 2 ψ Z 2 = μ 0R 2dp(ψ) dψ Pressure profile: p(ψ) Poloidal current density profile: F(ψ) Plasma boundary shape (fixed boundary) or Poloidal coil current (free boundary) F(ψ)dF(ψ) dψ determines the poloidal plasma shape. Coupling with transport analysis Input: p(ψ), q(ψ) = F dv 1 dψ R 2 Output: Metric quantities, Flux surface averaged quantities

19 Various Levels of Transport Modeling

20 Transport Modeling in the TASK code Diffusive transport equation: TASK/TR Diffusion equation for plasma density Flux-Gradient relation Conventional transport analysis Dynamical transport equation: TASK/TX: Continuity equation and equation of motion for plasma density Flux-averaged fluid equation Plasma rotation and transient phenomena Kinetic transport equation: TASK/FP: Gyrokinetic equation for momentum distribution function Bounce-averaged Fokker-Plank equation Modification of momentum distribution

21 Diffusive Transport Equation: TASK/TR Transport Equation Based on Gradient-Flux Relation: Γ = M F/ ρ where V: Volume, ρ: Normalized radius, V = dv/dρ Particle transport 1 V t (n sv ) = ( ) V ρ n s V s V ρ 2 n s D s ρ ρ + S s Toroidal momentum transport 1 V t (n su φs V ) = ( ) V ρ n s u φs V Ms V ρ 2 u φs n z μ s ρ ρ Heat transport ( ) 1 3 V 5/3 t 2 n st s V 5/3 Current diffusion B θ = [ t ρ η FR 0 R 2 + M s = 1 ( V ρ 3 ) V ρ 2 n st s V Es V ρ 2 T s n s χ s ρ R 0 F 2 ( V B θ μ 0 V ρ F ) ρ 2 R 2 ] η FR 0 R 2 J B ext + P s

22 Transport Processes Neoclassical transport Collisional transport in an inhomogeneous magnetic field Radial diffusion: usually small compared with turbulent diffusion Enhanced resistivity: due to trapped particles Bootstrap current: toroidal current driven by radial pressure gradient Ware pinch: Radial particle pinch driven by toroidal electric field Turbulent transport Various transport models: GLF23, CDBM, Weiland, Atomic transport: charge exchange, ionization, recombination Radiation transport Line radiation, Bremsstrahlung, Synchrotron radiation Parallel transport: along open magnetic field lines in SOL plasmas

23 Turbulent Transport Models CDBM model: current diffusive ballooning mode turbulence model developed by K. Itoh et al. Marginal stability condition of the current diffusive ballooning mode including turbulent transport coefficients as parameters GLF23 model: Gyro-Landau-Fluid turbulence model developed by Waltz and Kinsey (GA) Linear growth rate from gyro-landau-fluid model (ITG, TEM, ETG) Evaluate transport coefficients based on mixing length estimate Calibrate coefficients by the linear stability code GKS Calibrate coefficients by the nonlinear turbulence code GYRO Weiland model: developed by J. Weiland Based on ITG turbulence model

24 GLF23 Transport Model Linear growth rate from gyro-landau-fluid model Calibrate coefficients by the nonlinear turbulence code GYRO Good agreement with experimental data

25 CDBM Transport Model: CDBM05 Thermal Diffusivity (Marginal: γ = 0) χ TB = F(s,α,κ,ω E1 ) α 3/2 c2 ω 2 pe v A qr s α dependence of F(s,α,κ,ω E1 ) ω E1 =0 ω E1 =0.1 Magnetic shear s r dq q dr Pressure gradient α q 2 R dβ dr Elongation κ b/a E B rotation shear ω E1 r2 d E sv A dr rb Weak and negative magnetic shear, Shafranov shift, elongation, and E B rotation shear reduce thermal diffusivity. F ω E1 =0.2 ω E1 = F(s,α,κ,ω E1 ) = s - α ( 2κ 1/2 1 + κ 2 ) 3/ G 1 ω 2 E1 2(1 2s )(1 2s + 3s 2 ) for s = s α< s 5/2 1 + G 1 ω 2 E1 2(1 2s + 3s 2 + 2s 3 ) for s = s α>0

26 TFTR #88615 (L-mode, NBI heating)

27 DIII-D #78316 (L-mode, ECH and ICH heatings)

28 Comparison of Transport Models: ITPA Profile DB Deviation of Stored Energy CDBM CDBM05 GLF23 Weiland

29 1D Dynamic Transport Code: TASK/TX Dynamic Transport Equations (TASK/TX) M. Honda and A. Fukuyama, JCP 227 (2008) 2808 A set of flux-surface averaged equations Two fluid equations for electrons and ions Continuity equations Equations of motion (radial, poloidal and toroidal) Energy transport equations Maxwell s equations Slowing-down equations for beam ion component Diffusion equations for two-group neutrals Self-consistent description of plasma rotation and electric field Equation of motion rather than transport matrix Quasi-neutrality is not assumed.

30 Model Equation of Dynamic Transport Simulation Flux-surface-averaged multi-fluid equations: n s t = 1 r r (rn su sr ) + S s t (m sn s u sr )= 1 r r (rm sn s u 2 sr ) + 1 r m sn s u 2 sθ + e sn s (E r + u sθ B φ u sφ B θ ) r n st s t (m sn s u sθ )= 1 r 2 r (r2 m s n s u sr u sθ ) + e s n s (E θ u sr B φ ) + 1 ( r 3 n r 2 s m s μ s r r +F NC sθ ( ) 1 ms n s u sφ = t r + F C sθ + F W sθ + F X sθ + F L sθ r (rm sn s u sr u sφ ) + e s n s (E φ + u sr B θ ) + 1 r r ( ) rn s m s μ s r u sφ ) u sθ r t 3 2 n st s = 1 r +F C sφ + FW sφ + FX sφ + FL sφ ( ) 5 r r 2 u srn s T s n s χ s r T e + e s n s (E θ u sθ + E φ u sφ ) +P C s + P L s + P H s

31 Typical Ohmic Plasma Profiles at t = 50 ms JFT-2M like plasma composed of electron and hydrogen R = 1.3m, a = 0.35 m, b = 0.4m, B φb = 1.3T, I p = 0.2MA, S puff = m 2 s 1 γ = 0.8, Z eff = 2.0, Fixed turbulent coefficient profile E r (r) [kv/m] E 0.2 θ [mv/m] E φ [kv/m] B θ [T] B φ [T] n e [10 20 m -3 ] T e [kev] T i [kev] n 01 [10 14 m -3 ] n 02 [10 10 m -3 ] u er [m/s] u eθ [km/s] u eφ [km/s] D e [m 2 /s] χ e =χ i =μ e =μ i [m 2 /s] u ir [m/s] u iθ [km/s] u iφ [km/s] q j φ [MA/m 2 ] 0.0

32 Density Profile Modification Due to NBI Injection Modification of n and E r profile depends on the direction of NBI E r [kv/m] u bφ [km/s] q Co/Counter with I p : Density flattening/peaking n e [10 20 m -3 ] u er [km/s] j φ [MA/m 2 ] no NBI co counter T e [kev] u eθ [km/s] u iθ [km/s] T i [kev] 0.0 u eφ [km/s] u iφ [km/s]

33 Toroidal Rotation Due to Ion Orbit Loss Ion orbit loss near the edge region drives toroidal rotation Ref. M. Honda et al., NF (2008)

34 Source Modeling Heat and momentum sources: Alpha particle heating: sensitive to fuel density and momentum distribution Neutral beam injection: birth profile, finite size orbit, deposition to bulk plasma Waves: IC ( 50 MHz): fuel ion heating, current drive, rotation drive(?) LH ( 10 GHz): current drive EC ( 170 GHz): current drive, pre-ionization Particle source Gas puff, recycling: Neutral beam injection: Pellet injection: penetration, evaporation, ionization, drift motion

35 Wave Modeling Ray tracing: EC, LH Spatial evolution of ray position and wave number Wave length λ much less than scale length L: λ L Beam size d is sufficiently large (Fresnel condition): L d 2 /λ Beam tracing: EC New variables: beam radius, curvature of equi-phase surface Beam propagation: EC Under development: Time evolution of E(r, t)e i ωt Full wave analysis: IC, AW, MHD Stationary Maxwell s equation as a boundary problem Wave length λ comparable with scale length L Evanescent region, strong absorption, coupling with antenna

36 Wave Dispersion Analysis : TASK/DP Various Models of Dielectric Tensor ɛ (ω, k; r): Analytic model Resistive MHD model Collisional cold plasma model Collisional warm plasma model Kinetic model (Maxwelian, non-relativistic) Drift-kinetic model (Maxwellian, inhomogeneity) Hamiltonian formulation (cyclotron, bounce, precession) Numerical integrateion Kinetic model (Relativistic, Maxwellian) Kinetic model (Relativistic, arbitrary f (u)) Drift-kinetic model (Inhoogeneity, arbitrary f (u)) Hamiltonian formulation (arbitrary f (u)))

37 Geometrical Optics Ray Tracing: TASK/WR Wave length λ Characteristic scale length L of the medium Plane wave: Beam size d is sufficiently large Fresnel condition is well satisfied: L d 2 /λ Evolution along the ray trajectory τ Wave packet position r, wave number k, dielectric tensor K Ray tracing equation: dr dτ = K / K k ω dk dτ = K / K r ω Equation for wave energy W, group velocity u g, damping rate γ (u g W ) = 2γW

38 Beam Tracing: TASK/WR Beam size perpendicular to the beam direction: first order in ɛ Beam shape : Hermite polynomial: H n ) [ ] E(r) = Re C mn (ɛ 2 r)e(ɛ 2 r)h m (ɛξ 1 )H n (ɛξ 2 )e i s(r) φ(r) mn Amplitude : C mn, Polarization : e, Phase : s(r) + i φ(r) s(r) = s 0 (τ) + k 0 α(τ)[r α r α 0(τ)] s αβ[r α r α 0(τ)][r β r β 0 (τ)] φ(τ) = 1 2 φ αβ[r α r α 0(τ)][r β r β 0 (τ)] Position of beam axis : r 0, Wave number on beam axis: k 0 Curvature radius of equi-phase surface: R α = 1/λs αα Beam radius: d α = 2/φ αα R 1 d 1 Gaussian beam : case with m = 0, n = 0 R 2 d 2

39 Beam Propagation Equation Solvable condition for Maxwell s equation with beam field dr α 0 dτ = K k α dk 0 α dτ = K r α ds αβ dτ = 2 K r α r β dφ αβ dτ = ( 2 K r α k γ + 2 K r β k γ s αγ 2 K k γ k δ s αδ 2 K s r α βγ k γ ) φ βγ ( 2 K r β k γ + 2 K k γ k δ s αγs βδ + 2 K k γ k δ s βδ 2 K k γ k δφ αγφ βδ ) By integrating this set of 18 ordinary differential equations, we obtain trace of the beam axis, wave number on the beam axis, curvature of equi-phase surface, and beam size. Equation for the wave amplitude C mn (u g0 C mn 2) = 2 ( γ C mn 2) Group velocity: u g0, Damping rate: γ (e ɛ A e)/( K/ ω) φ αγ

40 Full wave analysis: TASK/WM magnetic surface coordinate: (ψ, θ, ϕ) Boundary-value problem of Maxwell s equation Kinetic dielectric tensor: ɛ E = ω2 c 2 ɛ E + i ωμ0 j ext Wave-particle resonance: Z[(ω nω c )/k v th ] Fast ion: Drift-kinetic [ t + v + (u d + u E ) + e α (v m E + u d E) ] α ε f α = 0 Poloidal and toroidal mode expansion Accurate estimation of k Eigenmode analysis: Complex eigen frequency whichmaximize wave amplitude for fixed excitation proportional to electron density

41 Fokker-Planck Analysis : TASK/FP Fokker-Planck equation for multi-species velocity distribution function: f s (p, p,ψ,t) f s = E( f s ) + C( f s ) + Q( f s ) + L( f s ) t E( f ): Acceleration term due to DC electric field C( f ): Coulomb collision term Q( f ): Quasi-linear term due to wave-particle resonance L( f ): Spatial diffusion term Bounce-averaged: Trapped particle effect, zero banana width Relativistic: momentum p, weakly relativistic collision term Nonlinear collision: momentum and energy conservation Multi-species: conservation between species Three-dimensional: spatial diffusion (neoclassical, turbulent)

42 ITER Modeling Needs based on Dr. Campbell talk at Cadarache, Sept 2007 Plasma scenario development: Preparation for operation Detailed design of auxiliary systems: H&CD, Diagnostics, Fueling, Design of plasma control system: Development and optimization of integrated control strategies Preparation of ITER operational programme: End-to-end scenario development Detailed pulse definition Experimental data evaluation: Pulse characterization and physics analysis Refinement of operation scenario and performance predictions

43 Analysis of EC propagation in ITER BB = RR = RA = RKAP = Q0 = QA = RF = 1.700E+05 NPHII= PA(1) = PZ(1) = PN(1) = PNS(1) = PTPR(1)= PTPP(1)= PTS(1) = MODELP1= 25. PA(2) = PZ(2) = PN(2) = PNS(2)= PTPR(2)= PTPP(2)= PTS(2) = MODELP2= 1. 4 ABS POWER ABS WEIGHT POWER

44 Analysis of IC propagation in ITER Minority heating in D phase: D+H Radial profile Wave electric field P abs by minority ion

45 ITER Plasma Transport Simulation with CDBM05 Inductive operation I p = 15 MA P NB = 40 MW on axis β N = 2.65 Hybrid operation I p = 12 MA P NB = 33 MW on axis β N = 2.68 Time evolution Radial profile Time evolution Radial profile

46 Alfvén Eigenmode Analysis by TASK/WM Alfvén eigenmode driven by alpha particles Calculated by the full wave module TASK/WM Toroidal mode number: n = 1 TAE is stable: Eigen mode frequency = (95.95 khz, 1.95 khz) Alfvén continuum frequency Alfvén eigenmode structure Alpha particle density

47 ITER Inductive Operation 15 MA Current rise in 70 s Behavior of plasma depends on timing of heating

48 Future Plan of the TASK code

49 Remaining Issues in Tokamak Plasma Modling Pedestal temperature: Transport barrier formation: ELM physics: Nonlinear MHD events: modeling of L/H transition turbulence transport model nonlinear behavior of ELM on transport modeling of plasma profile change Energetic-ion driven phenomena: coupling of Alfvén mode and drift waves Kinetic analysis of transport and MHD phenomena: non-maxwellian distribution Wave physics: full wave analysis of Bernstein waves Divertor plasma: Start up: and so on... plasma-wall interaction Rapid change of equilibrium and control

50 Summary Integrated modeling of burning plasmas is indispensable for exploiting optimized operation scenario of ITER and reliable design of DEMO. Discussion on international collaboration for the development of integrated ITER modeling is on going. There are many remaining issues in constructing comprehensive integrated code; especially, L/H transition mechanism, turbulent transport model, ELM physics, nonlinear MHD events, energetic particle driven phenomena and plasma wall-interactions. Solving those remaining issues requires not only large-scale computer simulations but also intensive modeling efforts based on experimental observations.

Integrated Modelling and Simulation of Toroidal Plasmas

Integrated Modelling and Simulation of Toroidal Plasmas 7th ITER International School on High performance computing in fusion science Aix-Marseille University, Aix-en-Provence, France 2014-08-28 Integrated Modelling and Simulation of Toroidal Plasmas Atsushi

More information

Integrated Transport Simulation Aiming at Burning Plasmas

Integrated Transport Simulation Aiming at Burning Plasmas Workshop on Transport and Confinement NIFS University, 2006/11/09 Integrated Transport Simulation Aiming at Burning Plasmas A. Fukuyama and M. Honda Department of Nuclear Engineering, Kyoto University

More information

Integrated Full Wave Analysis of RF Heating and Current Drive in Toroidal Plasmas

Integrated Full Wave Analysis of RF Heating and Current Drive in Toroidal Plasmas Integrated Full Wave Analysis of RF Heating and Current Drive in Toroidal Plasmas IAEA Fusion Energy Conference Chengdu, China 2006/10/20 A. Fukuyama, S. Murakami, A. Sonoda, M. Honda// Department of Nuclear

More information

TASK: Integrated Simulation Code

TASK: Integrated Simulation Code Workshop on Kinetic Theory in Stellarators Kyoto University, 2006/09/20 TASK: Integrated Simulation Code A. Fukuyama and M. Honda Department of Nuclear Engineering, Kyoto University presented by N. Nakajima

More information

Integrated Full-Wave Modeling of ICRF Heating in Tokamak Plasmas

Integrated Full-Wave Modeling of ICRF Heating in Tokamak Plasmas EPS PPC 2007, Warsaw, Poland D1-005, 2007/07/02 Integrated Full-Wave Modeling of ICRF Heating in Tokamak Plasmas A. Fukuyama, S. Murakami, T. Yamamoto, H. Nuga Department of Nuclear Engineering, Kyoto

More information

Present Status and Future Plan of TASK Code

Present Status and Future Plan of TASK Code Fifth BPSI meeting RIAM, Kyushu Univ, 2006/12/21 Present Status and Future Plan of TASK Code A. Fukuyama Department of Nuclear Engineering, Kyoto University in collaboration with M. Yagi and M. Honda Contents

More information

Integrated Heat Transport Simulation of High Ion Temperature Plasma of LHD

Integrated Heat Transport Simulation of High Ion Temperature Plasma of LHD 1 TH/P6-38 Integrated Heat Transport Simulation of High Ion Temperature Plasma of LHD S. Murakami 1, H. Yamaguchi 1, A. Sakai 1, K. Nagaoka 2, H. Takahashi 2, H. Nakano 2, M. Osakabe 2, K. Ida 2, M. Yoshinuma

More information

Direct drive by cyclotron heating can explain spontaneous rotation in tokamaks

Direct drive by cyclotron heating can explain spontaneous rotation in tokamaks Direct drive by cyclotron heating can explain spontaneous rotation in tokamaks J. W. Van Dam and L.-J. Zheng Institute for Fusion Studies University of Texas at Austin 12th US-EU Transport Task Force Annual

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

DIAGNOSTICS FOR ADVANCED TOKAMAK RESEARCH

DIAGNOSTICS FOR ADVANCED TOKAMAK RESEARCH DIAGNOSTICS FOR ADVANCED TOKAMAK RESEARCH by K.H. Burrell Presented at High Temperature Plasma Diagnostics 2 Conference Tucson, Arizona June 19 22, 2 134 /KHB/wj ROLE OF DIAGNOSTICS IN ADVANCED TOKAMAK

More information

Recent Progress in Integrate Code TASK

Recent Progress in Integrate Code TASK US-Japan JIFT Workshop on Integrated Modeling on Fusion Plasmas ORNL, Oak Ridge, USA 2007/01/29 Recent Progress in Integrate Code TASK Integrated Modeling of RF Heating and Current Drive in Tokamaks A.

More information

Modeling of Transport Barrier Based on Drift Alfvén Ballooning Mode Transport Model

Modeling of Transport Barrier Based on Drift Alfvén Ballooning Mode Transport Model 9th IAEA TM on H-mode Physics and Transport Barriers Catamaran Resort Hotel, San Diego 3-9-5 Modeling of Transport Barrier Based on Drift Alfvén Ballooning Mode Transport Model A. Fukuyama, M. Uchida and

More information

Current density modelling in JET and JT-60U identity plasma experiments. Paula Sirén

Current density modelling in JET and JT-60U identity plasma experiments. Paula Sirén Current density modelling in JET and JT-60U identity plasma experiments Paula Sirén 1/12 1/16 Euratom-TEKES Euratom-Tekes Annual Seminar 2013 28 24 May 2013 Paula Sirén Current density modelling in JET

More information

MHD Linear Stability Analysis Using a Full Wave Code

MHD Linear Stability Analysis Using a Full Wave Code US-Japan JIFT Workshop on Progress of Extended MHD Models NIFS, Toki,Japan 2007/03/27 MHD Linear Stability Analysis Using a Full Wave Code T. Akutsu and A. Fukuyama Department of Nuclear Engineering, Kyoto

More information

Integrated Particle Transport Simulation of NBI Plasmas in LHD )

Integrated Particle Transport Simulation of NBI Plasmas in LHD ) Integrated Particle Transport Simulation of NBI Plasmas in LHD Akira SAKAI, Sadayoshi MURAKAMI, Hiroyuki YAMAGUCHI, Arimitsu WAKASA, Atsushi FUKUYAMA, Kenichi NAGAOKA 1, Hiroyuki TAKAHASHI 1, Hirohisa

More information

Formation and Long Term Evolution of an Externally Driven Magnetic Island in Rotating Plasmas )

Formation and Long Term Evolution of an Externally Driven Magnetic Island in Rotating Plasmas ) Formation and Long Term Evolution of an Externally Driven Magnetic Island in Rotating Plasmas ) Yasutomo ISHII and Andrei SMOLYAKOV 1) Japan Atomic Energy Agency, Ibaraki 311-0102, Japan 1) University

More information

Rotation and Neoclassical Ripple Transport in ITER

Rotation and Neoclassical Ripple Transport in ITER Rotation and Neoclassical Ripple Transport in ITER Elizabeth J. Paul 1 Matt Landreman 1 Francesca Poli 2 Don Spong 3 Håkan Smith 4 William Dorland 1 1 University of Maryland 2 Princeton Plasma Physics

More information

Localized Electron Cyclotron Current Drive in DIII D: Experiment and Theory

Localized Electron Cyclotron Current Drive in DIII D: Experiment and Theory Localized Electron Cyclotron Current Drive in : Experiment and Theory by Y.R. Lin-Liu for C.C. Petty, T.C. Luce, R.W. Harvey,* L.L. Lao, P.A. Politzer, J. Lohr, M.A. Makowski, H.E. St John, A.D. Turnbull,

More information

Overview of Tokamak Rotation and Momentum Transport Phenomenology and Motivations

Overview of Tokamak Rotation and Momentum Transport Phenomenology and Motivations Overview of Tokamak Rotation and Momentum Transport Phenomenology and Motivations Lecture by: P.H. Diamond Notes by: C.J. Lee March 19, 2014 Abstract Toroidal rotation is a key part of the design of ITER

More information

Energetic Particle Physics in Tokamak Burning Plasmas

Energetic Particle Physics in Tokamak Burning Plasmas Energetic Particle Physics in Tokamak Burning Plasmas presented by C. Z. (Frank) Cheng in collaboration with N. N. Gorelenkov, G. J. Kramer, R. Nazikian, E. Fredrickson, Princeton Plasma Physics Laboratory

More information

Integration of Fokker Planck calculation in full wave FEM simulation of LH waves

Integration of Fokker Planck calculation in full wave FEM simulation of LH waves Integration of Fokker Planck calculation in full wave FEM simulation of LH waves O. Meneghini S. Shiraiwa R. Parker 51 st DPP APS, Atlanta November 4, 29 L H E A F * Work supported by USDOE awards DE-FC2-99ER54512

More information

TURBULENT TRANSPORT THEORY

TURBULENT TRANSPORT THEORY ASDEX Upgrade Max-Planck-Institut für Plasmaphysik TURBULENT TRANSPORT THEORY C. Angioni GYRO, J. Candy and R.E. Waltz, GA The problem of Transport Transport is the physics subject which studies the physical

More information

Advanced Tokamak Research in JT-60U and JT-60SA

Advanced Tokamak Research in JT-60U and JT-60SA I-07 Advanced Tokamak Research in and JT-60SA A. Isayama for the JT-60 team 18th International Toki Conference (ITC18) December 9-12, 2008 Ceratopia Toki, Toki Gifu JAPAN Contents Advanced tokamak development

More information

Non-Solenoidal Plasma Startup in

Non-Solenoidal Plasma Startup in Non-Solenoidal Plasma Startup in the A.C. Sontag for the Pegasus Research Team A.C. Sontag, 5th APS-DPP, Nov. 2, 28 1 Point-Source DC Helicity Injection Provides Viable Non-Solenoidal Startup Technique

More information

MHD-particle simulations and collective alpha-particle transport: analysis of ITER scenarios and perspectives for integrated modelling

MHD-particle simulations and collective alpha-particle transport: analysis of ITER scenarios and perspectives for integrated modelling MHD-particle simulations and collective alpha-particle transport: analysis of ITER scenarios and perspectives for integrated modelling G. Vlad, S. Briguglio, G. Fogaccia, F. Zonca Associazione Euratom-ENEA

More information

ITER Predictions Using the GYRO Verified and Experimentally Validated TGLF Transport Model

ITER Predictions Using the GYRO Verified and Experimentally Validated TGLF Transport Model 1 THC/3-3 ITER Predictions Using the GYRO Verified and Experimentally Validated TGLF Transport Model J.E. Kinsey, G.M. Staebler, J. Candy, and R.E. Waltz General Atomics, P.O. Box 8608, San Diego, California

More information

Comparison of Ion Internal Transport Barrier Formation between Hydrogen and Helium Dominated Plasmas )

Comparison of Ion Internal Transport Barrier Formation between Hydrogen and Helium Dominated Plasmas ) Comparison of Ion Internal Transport Barrier Formation between Hydrogen and Helium Dominated Plasmas ) Kenichi NAGAOKA 1,2), Hiromi TAKAHASHI 1,2), Kenji TANAKA 1), Masaki OSAKABE 1,2), Sadayoshi MURAKAMI

More information

Modeling of ELM Dynamics for ITER

Modeling of ELM Dynamics for ITER Modeling of ELM Dynamics for ITER A.Y. PANKIN 1, G. BATEMAN 1, D.P. BRENNAN 2, A.H. KRITZ 1, S. KRUGER 3, P.B. SNYDER 4 and the NIMROD team 1 Lehigh University, 16 Memorial Drive East, Bethlehem, PA 18015

More information

Experimental evaluation of nonlinear collision effect on the beam slowing-down process

Experimental evaluation of nonlinear collision effect on the beam slowing-down process P-2 Experimental evaluation of nonlinear collision effect on the beam slowing-down process H. Nuga R. Seki,2 S. Kamio M. Osakabe,2 M. Yokoyama,2 M. Isobe,2 K. Ogawa,2 National Institute for Fusion Science,

More information

Bounce-averaged gyrokinetic simulations of trapped electron turbulence in elongated tokamak plasmas

Bounce-averaged gyrokinetic simulations of trapped electron turbulence in elongated tokamak plasmas Bounce-averaged gyrokinetic simulations of trapped electron turbulence in elongated tokamak plasmas Lei Qi a, Jaemin Kwon a, T. S. Hahm a,b and Sumin Yi a a National Fusion Research Institute (NFRI), Daejeon,

More information

Theory Work in Support of C-Mod

Theory Work in Support of C-Mod Theory Work in Support of C-Mod 2/23/04 C-Mod PAC Presentation Peter J. Catto for the PSFC theory group MC & LH studies ITB investigations Neutrals & rotation BOUT improvements TORIC ICRF Mode Conversion

More information

A THEORETICAL AND EXPERIMENTAL INVESTIGATION INTO ENERGY TRANSPORT IN HIGH TEMPERATURE TOKAMAK PLASMAS

A THEORETICAL AND EXPERIMENTAL INVESTIGATION INTO ENERGY TRANSPORT IN HIGH TEMPERATURE TOKAMAK PLASMAS A THEORETICAL AND EXPERIMENTAL INVESTIGATION INTO ENERGY TRANSPORT IN HIGH TEMPERATURE TOKAMAK PLASMAS Presented by D.P. SCHISSEL Presented to APS Centennial Meeting March 20 26, 1999 Atlanta, Georgia

More information

Studies of Lower Hybrid Range of Frequencies Actuators in the ARC Device

Studies of Lower Hybrid Range of Frequencies Actuators in the ARC Device Studies of Lower Hybrid Range of Frequencies Actuators in the ARC Device P. T. Bonoli, Y. Lin. S. Shiraiwa, G. M. Wallace, J. C. Wright, and S. J. Wukitch MIT PSFC, Cambridge, MA 02139 59th Annual Meeting

More information

TRANSPORT PROGRAM C-MOD 5 YEAR REVIEW MAY, 2003 PRESENTED BY MARTIN GREENWALD MIT PLASMA SCIENCE & FUSION CENTER

TRANSPORT PROGRAM C-MOD 5 YEAR REVIEW MAY, 2003 PRESENTED BY MARTIN GREENWALD MIT PLASMA SCIENCE & FUSION CENTER TRANSPORT PROGRAM C-Mod C-MOD 5 YEAR REVIEW MAY, 2003 PRESENTED BY MARTIN GREENWALD MIT PLASMA SCIENCE & FUSION CENTER C-MOD - OPPORTUNITIES AND CHALLENGES Prediction and control are the ultimate goals

More information

Self-consistent modeling of ITER with BALDUR integrated predictive modeling code

Self-consistent modeling of ITER with BALDUR integrated predictive modeling code Self-consistent modeling of ITER with BALDUR integrated predictive modeling code Thawatchai Onjun Sirindhorn International Institute of Technology, Thammasat University, Klong Luang, Pathumthani, 12121,

More information

MHD. Jeff Freidberg MIT

MHD. Jeff Freidberg MIT MHD Jeff Freidberg MIT 1 What is MHD MHD stands for magnetohydrodynamics MHD is a simple, self-consistent fluid description of a fusion plasma Its main application involves the macroscopic equilibrium

More information

OVERVIEW OF THE ALCATOR C-MOD PROGRAM. IAEA-FEC November, 2004 Alcator Team Presented by Martin Greenwald MIT Plasma Science & Fusion Center

OVERVIEW OF THE ALCATOR C-MOD PROGRAM. IAEA-FEC November, 2004 Alcator Team Presented by Martin Greenwald MIT Plasma Science & Fusion Center OVERVIEW OF THE ALCATOR C-MOD PROGRAM IAEA-FEC November, 2004 Alcator Team Presented by Martin Greenwald MIT Plasma Science & Fusion Center OUTLINE C-Mod is compact, high field, high density, high power

More information

Plasma shielding during ITER disruptions

Plasma shielding during ITER disruptions Plasma shielding during ITER disruptions Sergey Pestchanyi and Richard Pitts 1 Integrated tokamak code TOKES is a workshop with various tools objects Radiation bremsstrahlung recombination s line s cyclotron

More information

Recent Development of LHD Experiment. O.Motojima for the LHD team National Institute for Fusion Science

Recent Development of LHD Experiment. O.Motojima for the LHD team National Institute for Fusion Science Recent Development of LHD Experiment O.Motojima for the LHD team National Institute for Fusion Science 4521 1 Primary goal of LHD project 1. Transport studies in sufficiently high n E T regime relevant

More information

Understanding physics issues of relevance to ITER

Understanding physics issues of relevance to ITER Understanding physics issues of relevance to ITER presented by P. Mantica IFP-CNR, Euratom/ENEA-CNR Association, Milano, Italy on behalf of contributors to the EFDA-JET Work Programme Brief summary of

More information

Simulation Study of Interaction between Energetic Ions and Alfvén Eigenmodes in LHD

Simulation Study of Interaction between Energetic Ions and Alfvén Eigenmodes in LHD 1 Simulation Study of Interaction between Energetic Ions and Alfvén Eigenmodes in LHD Y. Todo 1), N. Nakajima 1), M. Osakabe 1), S. Yamamoto 2), D. A. Spong 3) 1) National Institute for Fusion Science,

More information

Introduction to Plasma Physics

Introduction to Plasma Physics Introduction to Plasma Physics Hartmut Zohm Max-Planck-Institut für Plasmaphysik 85748 Garching DPG Advanced Physics School The Physics of ITER Bad Honnef, 22.09.2014 A simplistic view on a Fusion Power

More information

Der Stellarator Ein alternatives Einschlusskonzept für ein Fusionskraftwerk

Der Stellarator Ein alternatives Einschlusskonzept für ein Fusionskraftwerk Max-Planck-Institut für Plasmaphysik Der Stellarator Ein alternatives Einschlusskonzept für ein Fusionskraftwerk Robert Wolf robert.wolf@ipp.mpg.de www.ipp.mpg.de Contents Magnetic confinement The stellarator

More information

Characteristics of the H-mode H and Extrapolation to ITER

Characteristics of the H-mode H and Extrapolation to ITER Characteristics of the H-mode H Pedestal and Extrapolation to ITER The H-mode Pedestal Study Group of the International Tokamak Physics Activity presented by T.Osborne 19th IAEA Fusion Energy Conference

More information

Impact of Localized ECRH on NBI and ICRH Driven Alfven Eigenmodes in the ASDEX Upgrade Tokamak

Impact of Localized ECRH on NBI and ICRH Driven Alfven Eigenmodes in the ASDEX Upgrade Tokamak Impact of Localized ECRH on NBI and ICRH Driven Alfven Eigenmodes in the ASDEX Upgrade Tokamak M. Garcia-Munoz M. A. Van Zeeland, S. Sharapov, Ph. Lauber, J. Ayllon, I. Classen, G. Conway, J. Ferreira,

More information

Effects of Alpha Particle Transport Driven by Alfvénic Instabilities on Proposed Burning Plasma Scenarios on ITER

Effects of Alpha Particle Transport Driven by Alfvénic Instabilities on Proposed Burning Plasma Scenarios on ITER Effects of Alpha Particle Transport Driven by Alfvénic Instabilities on Proposed Burning Plasma Scenarios on ITER G. Vlad, S. Briguglio, G. Fogaccia, F. Zonca Associazione Euratom-ENEA sulla Fusione, C.R.

More information

SUMMARY OF EXPERIMENTAL CORE TURBULENCE CHARACTERISTICS IN OH AND ECRH T-10 TOKAMAK PLASMAS

SUMMARY OF EXPERIMENTAL CORE TURBULENCE CHARACTERISTICS IN OH AND ECRH T-10 TOKAMAK PLASMAS SUMMARY OF EXPERIMENTAL CORE TURBULENCE CHARACTERISTICS IN OH AND ECRH T-1 TOKAMAK PLASMAS V. Vershkov, L.G. Eliseev, S.A. Grashin. A.V. Melnikov, D.A. Shelukhin, S.V. Soldatov, A.O. Urazbaev and T-1 team

More information

Experimental analysis and predictive simulation of heat transport using TASK3D code

Experimental analysis and predictive simulation of heat transport using TASK3D code Experimental analysis and predictive simulation of heat transport using TASK3D code A. Wakasa 1, A. Fukuyama 2, S. Murakami 2, N. Takeda 2, and, M. Yokoyama 3 1 Research Organization for Information Science

More information

GTC Simulation of Turbulence and Transport in Tokamak Plasmas

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

More information

Benchmarking of electron cyclotron heating and current drive codes on ITER scenarios within the European Integrated Tokamak Modelling framework

Benchmarking of electron cyclotron heating and current drive codes on ITER scenarios within the European Integrated Tokamak Modelling framework Benchmarking of electron cyclotron heating and current drive codes on ITER scenarios within the European Integrated Tokamak Modelling framework L. Figini 1,a, J. Decker 2, D. Farina 1, N. B. Marushchenko

More information

Progressing Performance Tokamak Core Physics. Marco Wischmeier Max-Planck-Institut für Plasmaphysik Garching marco.wischmeier at ipp.mpg.

Progressing Performance Tokamak Core Physics. Marco Wischmeier Max-Planck-Institut für Plasmaphysik Garching marco.wischmeier at ipp.mpg. Progressing Performance Tokamak Core Physics Marco Wischmeier Max-Planck-Institut für Plasmaphysik 85748 Garching marco.wischmeier at ipp.mpg.de Joint ICTP-IAEA College on Advanced Plasma Physics, Triest,

More information

Lower Hybrid Current Drive Experiments on Alcator C-Mod: Comparison with Theory and Simulation

Lower Hybrid Current Drive Experiments on Alcator C-Mod: Comparison with Theory and Simulation Lower Hybrid Current Drive Experiments on Alcator C-Mod: Comparison with Theory and Simulation P.T. Bonoli, A. E. Hubbard, J. Ko, R. Parker, A.E. Schmidt, G. Wallace, J. C. Wright, and the Alcator C-Mod

More information

Introduction to Fusion Physics

Introduction to Fusion Physics Introduction to Fusion Physics Hartmut Zohm Max-Planck-Institut für Plasmaphysik 85748 Garching DPG Advanced Physics School The Physics of ITER Bad Honnef, 22.09.2014 Energy from nuclear fusion Reduction

More information

Active and Fast Particle Driven Alfvén Eigenmodes in Alcator C-Mod

Active and Fast Particle Driven Alfvén Eigenmodes in Alcator C-Mod Active and Fast Particle Driven Alfvén Eigenmodes in Alcator C-Mod JUST DID IT. J A Snipes, N Basse, C Boswell, E Edlund, A Fasoli #, N N Gorelenkov, R S Granetz, L Lin, Y Lin, R Parker, M Porkolab, J

More information

Predicting the Rotation Profile in ITER

Predicting the Rotation Profile in ITER Predicting the Rotation Profile in ITER by C. Chrystal1 in collaboration with B. A. Grierson2, S. R. Haskey2, A. C. Sontag3, M. W. Shafer3, F. M. Poli2, and J. S. degrassie1 1General Atomics 2Princeton

More information

Study of B +1, B +4 and B +5 impurity poloidal rotation in Alcator C-Mod plasmas for 0.75 ρ 1.0.

Study of B +1, B +4 and B +5 impurity poloidal rotation in Alcator C-Mod plasmas for 0.75 ρ 1.0. Study of B +1, B +4 and B +5 impurity poloidal rotation in Alcator C-Mod plasmas for 0.75 ρ 1.0. Igor Bespamyatnov, William Rowan, Ronald Bravenec, and Kenneth Gentle The University of Texas at Austin,

More information

Joint ITER-IAEA-ICTP Advanced Workshop on Fusion and Plasma Physics October Introduction to Fusion Leading to ITER

Joint ITER-IAEA-ICTP Advanced Workshop on Fusion and Plasma Physics October Introduction to Fusion Leading to ITER 2267-1 Joint ITER-IAEA-ICTP Advanced Workshop on Fusion and Plasma Physics 3-14 October 2011 Introduction to Fusion Leading to ITER SNIPES Joseph Allan Directorate for Plasma Operation Plasma Operations

More information

Studies of H Mode Plasmas Produced Directly by Pellet Injection in DIII D

Studies of H Mode Plasmas Produced Directly by Pellet Injection in DIII D Studies of H Mode Plasmas Produced Directly by Pellet Injection in by P. Gohil in collaboration with L.R. Baylor,* K.H. Burrell, T.C. Jernigan,* G.R. McKee, *Oak Ridge National Laboratory University of

More information

Analysis and modelling of MHD instabilities in DIII-D plasmas for the ITER mission

Analysis and modelling of MHD instabilities in DIII-D plasmas for the ITER mission Analysis and modelling of MHD instabilities in DIII-D plasmas for the ITER mission by F. Turco 1 with J.M. Hanson 1, A.D. Turnbull 2, G.A. Navratil 1, C. Paz-Soldan 2, F. Carpanese 3, C.C. Petty 2, T.C.

More information

Generating of fusion plasma neutron source with AFSI for Serpent MC neutronics computing Serpent UGM 2015 Knoxville, TN,

Generating of fusion plasma neutron source with AFSI for Serpent MC neutronics computing Serpent UGM 2015 Knoxville, TN, Generating of fusion plasma neutron source with AFSI for Serpent MC neutronics computing Serpent UGM 2015 Knoxville, TN, 14.10.2015 Paula Sirén VTT Technical Research Centre of Finland, P.O Box 1000, 02044

More information

Full-wave Simulations of Lower Hybrid Wave Propagation in the EAST Tokamak

Full-wave Simulations of Lower Hybrid Wave Propagation in the EAST Tokamak Full-wave Simulations of Lower Hybrid Wave Propagation in the EAST Tokamak P. T. BONOLI, J. P. LEE, S. SHIRAIWA, J. C. WRIGHT, MIT-PSFC, B. DING, C. YANG, CAS-IPP, Hefei 57 th Annual Meeting of the APS

More information

A Hybrid Inductive Scenario for a Pulsed- Burn RFP Reactor with Quasi-Steady Current. John Sarff

A Hybrid Inductive Scenario for a Pulsed- Burn RFP Reactor with Quasi-Steady Current. John Sarff A Hybrid Inductive Scenario for a Pulsed- Burn RFP Reactor with Quasi-Steady Current John Sarff 12th IEA RFP Workshop Kyoto Institute of Technology, Kyoto, Japan Mar 26-28, 2007 The RFP fusion development

More information

On Electron-Cyclotron Waves in Relativistic Non-Thermal Tokamak Plasmas

On Electron-Cyclotron Waves in Relativistic Non-Thermal Tokamak Plasmas 1 On Electron-Cyclotron Waves in Relativistic Non-Thermal Tokamak Plasmas Lj. Nikolić and M.M. Škorić Vinča Institute of Nuclear Sciences, P.O.Box 522, Belgrade 11001, Serbia and Montenegro ljnikoli@tesla.rcub.bg.ac.yu

More information

Impact of Toroidal Flow on ITB H-Mode Plasma Performance in Fusion Tokamak

Impact of Toroidal Flow on ITB H-Mode Plasma Performance in Fusion Tokamak Impact of oroidal Flow on I H-Mode Plasma Performance in Fusion okamak oonyarit Chatthong 1,*, hawatchai Onjun 1, Roppon Picha and Nopporn Poolyarat 3 1 School of Manufacturing Systems and Mechanical Engineering,

More information

Predictive Study on High Performance Modes of Operation in HL-2A 1

Predictive Study on High Performance Modes of Operation in HL-2A 1 1 EX/P-0 Predictive Study on High Performance Modes of Oration in HL-A 1 Qingdi GAO 1), R. V. BUDNY ), Fangzhu LI 1), Jinhua ZHANG 1), Hongng QU 1) 1) Southwestern Institute of Physics, Chengdu, Sichuan,

More information

Innovative Concepts Workshop Austin, Texas February 13-15, 2006

Innovative Concepts Workshop Austin, Texas February 13-15, 2006 Don Spong Oak Ridge National Laboratory Acknowledgements: Jeff Harris, Hideo Sugama, Shin Nishimura, Andrew Ware, Steve Hirshman, Wayne Houlberg, Jim Lyon Innovative Concepts Workshop Austin, Texas February

More information

Characteristics of Internal Transport Barrier in JT-60U Reversed Shear Plasmas

Characteristics of Internal Transport Barrier in JT-60U Reversed Shear Plasmas Characteristics of Internal Transport Barrier in JT-6U Reversed Shear Plasmas Y. Sakamoto, Y. Kamada, S. Ide, T. Fujita, H. Shirai, T. Takizuka, Y. Koide, T. Fukuda, T. Oikawa, T. Suzuki, K. Shinohara,

More information

C-Mod Core Transport Program. Presented by Martin Greenwald C-Mod PAC Feb. 6-8, 2008 MIT Plasma Science & Fusion Center

C-Mod Core Transport Program. Presented by Martin Greenwald C-Mod PAC Feb. 6-8, 2008 MIT Plasma Science & Fusion Center C-Mod Core Transport Program Presented by Martin Greenwald C-Mod PAC Feb. 6-8, 2008 MIT Plasma Science & Fusion Center Practical Motivations for Transport Research Overall plasma behavior must be robustly

More information

0 Magnetically Confined Plasma

0 Magnetically Confined Plasma 0 Magnetically Confined Plasma 0.1 Particle Motion in Prescribed Fields The equation of motion for species s (= e, i) is written as d v ( s m s dt = q s E + vs B). The motion in a constant magnetic field

More information

Estimations of Beam-Beam Fusion Reaction Rates in the Deuterium Plasma Experiment on LHD )

Estimations of Beam-Beam Fusion Reaction Rates in the Deuterium Plasma Experiment on LHD ) Estimations of Beam-Beam Fusion Reaction Rates in the Deuterium Plasma Experiment on LHD ) Masayuki HOMMA, Sadayoshi MURAKAMI, Hideo NUGA and Hiroyuki YAMAGUCHI Department of Nuclear Engineering, Kyoto

More information

Toroidal confinement of non-neutral plasma. Martin Droba

Toroidal confinement of non-neutral plasma. Martin Droba Toroidal confinement of non-neutral plasma Martin Droba Contents Experiments with toroidal non-neutral plasma Magnetic surfaces CNT and IAP-high current ring Conclusion 2. Experiments with toroidal non-neutral

More information

Impact of neutral atoms on plasma turbulence in the tokamak edge region

Impact of neutral atoms on plasma turbulence in the tokamak edge region Impact of neutral atoms on plasma turbulence in the tokamak edge region C. Wersal P. Ricci, F.D. Halpern, R. Jorge, J. Morales, P. Paruta, F. Riva Theory of Fusion Plasmas Joint Varenna-Lausanne International

More information

Experimental Study of the Stability of Alfvén Eigenmodes on JET

Experimental Study of the Stability of Alfvén Eigenmodes on JET IAEA FEC, Paper EX/P-7 Experimental Study of the Stability of Alfvén Eigenmodes on JET D.Testa,, A.Fasoli,, G.Fu 4, A.Jaun 3, D.Borba, P.de Vries 6, and JET-EFDA contributors [] Plasma Science and Fusion

More information

The RFP: Plasma Confinement with a Reversed Twist

The RFP: Plasma Confinement with a Reversed Twist The RFP: Plasma Confinement with a Reversed Twist JOHN SARFF Department of Physics University of Wisconsin-Madison Invited Tutorial 1997 Meeting APS DPP Pittsburgh Nov. 19, 1997 A tutorial on the Reversed

More information

(a) (b) (c) (d) (e) (f) r (minor radius) time. time. Soft X-ray. T_e contours (ECE) r (minor radius) time time

(a) (b) (c) (d) (e) (f) r (minor radius) time. time. Soft X-ray. T_e contours (ECE) r (minor radius) time time Studies of Spherical Tori, Stellarators and Anisotropic Pressure with M3D 1 L.E. Sugiyama 1), W. Park 2), H.R. Strauss 3), S.R. Hudson 2), D. Stutman 4), X-Z. Tang 2) 1) Massachusetts Institute of Technology,

More information

EFFECT OF EDGE NEUTRAL SOUCE PROFILE ON H-MODE PEDESTAL HEIGHT AND ELM SIZE

EFFECT OF EDGE NEUTRAL SOUCE PROFILE ON H-MODE PEDESTAL HEIGHT AND ELM SIZE EFFECT OF EDGE NEUTRAL SOUCE PROFILE ON H-MODE PEDESTAL HEIGHT AND ELM SIZE T.H. Osborne 1, P.B. Snyder 1, R.J. Groebner 1, A.W. Leonard 1, M.E. Fenstermacher 2, and the DIII-D Group 47 th Annual Meeting

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

Development of LH wave fullwave simulation based on FEM

Development of LH wave fullwave simulation based on FEM Development of LH wave fullwave simulation based on FEM S. Shiraiwa and O. Meneghini on behalf of LHCD group of Alacator C-Mod PSFC, MIT 2010/03/10 San-Diego, CA Special acknowledgements : R. Parker, P.

More information

THE DIII D PROGRAM THREE-YEAR PLAN

THE DIII D PROGRAM THREE-YEAR PLAN THE PROGRAM THREE-YEAR PLAN by T.S. Taylor Presented to Program Advisory Committee Meeting January 2 21, 2 3 /TST/wj PURPOSE OF TALK Show that the program plan is appropriate to meet the goals and is well-aligned

More information

C-Mod Transport Program

C-Mod Transport Program C-Mod Transport Program PAC 2006 Presented by Martin Greenwald MIT Plasma Science & Fusion Center 1/26/2006 Introduction Programmatic Focus Transport is a broad topic so where do we focus? Where C-Mod

More information

RELATIVISTIC EFFECTS IN ELECTRON CYCLOTRON RESONANCE HEATING AND CURRENT DRIVE

RELATIVISTIC EFFECTS IN ELECTRON CYCLOTRON RESONANCE HEATING AND CURRENT DRIVE RELATIVISTIC EFFECTS IN ELECTRON CYCLOTRON RESONANCE HEATING AND CURRENT DRIVE Abhay K. Ram Plasma Science and Fusion Center Massachusetts Institute of Technology Cambridge, MA 02139. U.S.A. Joan Decker

More information

Gyrokinetic Transport Driven by Energetic Particle Modes

Gyrokinetic Transport Driven by Energetic Particle Modes Gyrokinetic Transport Driven by Energetic Particle Modes by Eric Bass (General Atomics) Collaborators: Ron Waltz, Ming Chu GSEP Workshop General Atomics August 10, 2009 Outline I. Background Alfvén (TAE/EPM)

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

Study of High-energy Ion Tail Formation with Second Harmonic ICRF Heating and NBI in LHD

Study of High-energy Ion Tail Formation with Second Harmonic ICRF Heating and NBI in LHD 21st IAEA Fusion Energy Conference Chengdu, China, 16-21 October, 2006 IAEA-CN-149/ Study of High-energy Ion Tail Formation with Second Harmonic ICRF Heating and NBI in LHD K. Saito et al. NIFS-851 Oct.

More information

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

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

More information

Shear Flow Generation in Stellarators - Configurational Variations

Shear Flow Generation in Stellarators - Configurational Variations Shear Flow Generation in Stellarators - Configurational Variations D. A. Spong 1), A. S. Ware 2), S. P. Hirshman 1), J. H. Harris 1), L. A. Berry 1) 1) Oak Ridge National Laboratory, Oak Ridge, Tennessee

More information

- Effect of Stochastic Field and Resonant Magnetic Perturbation on Global MHD Fluctuation -

- Effect of Stochastic Field and Resonant Magnetic Perturbation on Global MHD Fluctuation - 15TH WORKSHOP ON MHD STABILITY CONTROL: "US-Japan Workshop on 3D Magnetic Field Effects in MHD Control" U. Wisconsin, Madison, Nov 15-17, 17, 2010 LHD experiments relevant to Tokamak MHD control - Effect

More information

Stationary, High Bootstrap Fraction Plasmas in DIII-D Without Inductive Current Control

Stationary, High Bootstrap Fraction Plasmas in DIII-D Without Inductive Current Control Stationary, High Bootstrap Fraction Plasmas in DIII-D Without Inductive Current Control P. A. Politzer, 1 A. W. Hyatt, 1 T. C. Luce, 1 F. W. Perkins, 4 R. Prater, 1 A. D. Turnbull, 1 D. P. Brennan, 5 J.

More information

Integrated modeling of LHCD non- induc6ve scenario development on Alcator C- Mod

Integrated modeling of LHCD non- induc6ve scenario development on Alcator C- Mod Integrated modeling of LHCD non- induc6ve scenario development on Alcator C- Mod S. Shiraiwa, P. Bonoli, R. Parker, F. Poli 1, G. Wallace, and J, R. Wilson 1 PSFC, MIT and 1 PPPL 40th European Physical

More information

Triggering Mechanisms for Transport Barriers

Triggering Mechanisms for Transport Barriers Triggering Mechanisms for Transport Barriers O. Dumbrajs, J. Heikkinen 1, S. Karttunen 1, T. Kiviniemi, T. Kurki-Suonio, M. Mantsinen, K. Rantamäki 1, S. Saarelma, R. Salomaa, S. Sipilä, T. Tala 1 Euratom-TEKES

More information

GA A22571 REDUCTION OF TOROIDAL ROTATION BY FAST WAVE POWER IN DIII D

GA A22571 REDUCTION OF TOROIDAL ROTATION BY FAST WAVE POWER IN DIII D GA A22571 REDUCTION OF TOROIDAL ROTATION BY FAST WAVE POWER IN DIII D by J.S. degrassie, D.R. BAKER, K.H. BURRELL, C.M. GREENFIELD, H. IKEZI, Y.R. LIN-LIU, C.C. PETTY, and R. PRATER APRIL 1997 This report

More information

DYNAMICS OF THE FORMATION, SUSTAINMENT, AND DESTRUCTION OF TRANSPORT BARRIERS IN MAGNETICALLY CONTAINED FUSION PLASMAS

DYNAMICS OF THE FORMATION, SUSTAINMENT, AND DESTRUCTION OF TRANSPORT BARRIERS IN MAGNETICALLY CONTAINED FUSION PLASMAS GA A23775 DYNAMICS OF THE FORMATION, SUSTAINMENT, AND DESTRUCTION OF TRANSPORT BARRIERS IN MAGNETICALLY CONTAINED FUSION PLASMAS by P. GOHIL NOVEMBER 2001 QTYUIOP DISCLAIMER This report was prepared as

More information

Full-wave Electromagnetic Field Simulations in the Lower Hybrid Range of Frequencies

Full-wave Electromagnetic Field Simulations in the Lower Hybrid Range of Frequencies Full-wave Electromagnetic Field Simulations in the Lower Hybrid Range of Frequencies P.T. Bonoli, J.C. Wright, M. Porkolab, PSFC, MIT M. Brambilla, IPP, Garching, Germany E. D Azevedo, ORNL, Oak Ridge,

More information

Spontaneous tokamak rotation: observations turbulent momentum transport has to explain

Spontaneous tokamak rotation: observations turbulent momentum transport has to explain Spontaneous tokamak rotation: observations turbulent momentum transport has to explain Ian H Hutchinson Plasma Science and Fusion Center and Nuclear Science and Engineering Massachusetts Institute of Technology

More information

Sawtooth mixing of alphas, knock on D, T ions and its influence on NPA spectra in ITER plasma

Sawtooth mixing of alphas, knock on D, T ions and its influence on NPA spectra in ITER plasma Sawtooth mixing of alphas, knock on D, T ions and its influence on NPA spectra in ITER plasma F.S. Zaitsev 1, 4, N.N. Gorelenkov 2, M.P. Petrov 3, V.I. Afanasyev 3, M.I. Mironov 3 1 Scientific Research

More information

ITER operation. Ben Dudson. 14 th March Department of Physics, University of York, Heslington, York YO10 5DD, UK

ITER operation. Ben Dudson. 14 th March Department of Physics, University of York, Heslington, York YO10 5DD, UK ITER operation Ben Dudson Department of Physics, University of York, Heslington, York YO10 5DD, UK 14 th March 2014 Ben Dudson Magnetic Confinement Fusion (1 of 18) ITER Some key statistics for ITER are:

More information

Characterization of neo-classical tearing modes in high-performance I- mode plasmas with ICRF mode conversion flow drive on Alcator C-Mod

Characterization of neo-classical tearing modes in high-performance I- mode plasmas with ICRF mode conversion flow drive on Alcator C-Mod 1 EX/P4-22 Characterization of neo-classical tearing modes in high-performance I- mode plasmas with ICRF mode conversion flow drive on Alcator C-Mod Y. Lin, R.S. Granetz, A.E. Hubbard, M.L. Reinke, J.E.

More information

EFFECT OF PLASMA FLOWS ON TURBULENT TRANSPORT AND MHD STABILITY*

EFFECT OF PLASMA FLOWS ON TURBULENT TRANSPORT AND MHD STABILITY* EFFECT OF PLASMA FLOWS ON TURBULENT TRANSPORT AND MHD STABILITY* by K.H. BURRELL Presented at the Transport Task Force Meeting Annapolis, Maryland April 3 6, 22 *Work supported by U.S. Department of Energy

More information

Observation of Neo-Classical Ion Pinch in the Electric Tokamak*

Observation of Neo-Classical Ion Pinch in the Electric Tokamak* 1 EX/P6-29 Observation of Neo-Classical Ion Pinch in the Electric Tokamak* R. J. Taylor, T. A. Carter, J.-L. Gauvreau, P.-A. Gourdain, A. Grossman, D. J. LaFonteese, D. C. Pace, L. W. Schmitz, A. E. White,

More information

Time-dependent Modeling of Sustained Advanced Tokamak Scenarios

Time-dependent Modeling of Sustained Advanced Tokamak Scenarios Time-dependent Modeling of Sustained Advanced Tokamak Scenarios T. A. Casper, L. L. LoDestro and L. D. Pearlstein LLNL M. Murakami ORNL L.L. Lao and H.E. StJohn GA We are modeling time-dependent behavior

More information