Recent Progress in Integrate Code TASK

Size: px
Start display at page:

Download "Recent Progress in Integrate Code TASK"

Transcription

1 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. Fukuyama Department of Nuclear Engineering, Kyoto University in collaboration with S. Murakami, M. Honda, A. Sonoda, T. Yamamoto

2 Outline Integrated Simulation of Fusion Plasmas Progress of TASK Code Development Self-Consistent Analysis of RF Heating and Current Drive Full Wave Analysis Including FLR Effects Future Plan of Integrated Modeling Summary

3 Burning Plasma Simulation Broad time scale: 100GHz 1000s Energetic Ion Confinement Broad Spatial scale: 10 μm 10m Transport Barrier MHD Stability Core Transport Non-Inductive CD EC LH IC MHD Turbulent Transport Impurity Transport SOL Transport RF Heating NBI Heating Neutral Transport 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

4 Integrated Tokamak Simulation Integrated Simulation Equilibrium: Magnetic Island Diagnostic model Control model Anisotropic Pressure Fixed boundary Free boundary Time evolution Core Plasma Transport: Neoclassical Tranport Turbulent Tranport Neutral Transport Impurity Transport Energetic Particles Diffusive transport Dynamic transport Kinetic transport Orbit following Macroscopic Stability: Plasma Deformation MHD stability Kinetic stability Wave Heating Current Drive: Ray/Beam tracing Wave Despersion Velocity Distribut. Fn Full wave Peripheral Plasma Transport: Turbulent Transport Plasma-Wall Interaction Neutral Transport Impurity Transport Radiation Transport Fluid transport Kinetic transport

5 Multi-Hierarchy and Integrated Approaches Multi-Hierarchu Simulation Integrated Simulation Diagnostic model Control model Device size Nonlinear Equilibrium: Magnetic Island Anisotropic Pressure MHD Simulation Magnetic island size Core Plasma Transport: Ion gyroradius Extended MHD Simulation Neoclassical Tranport Turbulent Tranport Neutral Transport Impurity Transport Collsionless skin depth Energetic Particles Debye length Turbulence Simulation Macroscopic Stability: Plasma Deformation Electron gyroradius Particle distance Molecular Dynamics Wave Heating Current Drive: Wave Despersion Velocity Distribut. Fn Peripheral Plasma Transport: Turbulent Transport Plasma-Wall Interaction Neutral Transport Impurity Transport Radiation Transport

6 BPSI: Burning Plasma Simulation Initiative Integrated code: TASK and TOPICS

7 TASK Code Transport Analysing System for TokamaK Features Core of Integrated Modeling Code in BPSI Modular structure Reference data interface and standard data set Uniform user interface Various Heating and Current Drive Scheme High Portability Development using CVS (Concurrent Version System) Open Source: Parallel Processing using MPI Library Extension to Toroidal Helical Plasmas

8 Recent Progress of TASK Fortran95 TASK V1.0: Fortran95 compiler required (g95, pgf95, xlf95, ifort,...) TASK/EQ, TASK/TR: Fortran95 (Module, Dynamic allocation) Module structure Standard dataset: partially implemented Data exchange interface: prototype Execution control interface: prototype New module: fromtopicsby M. Azumi TOPICS/EQU: Free boundary 2D equilibrium TOPICS/NBI: Beam deposition + 1D Fokker-Planck MHD stability component: coming Self-consistent wave analysis Dynamic transport analysis: by M. Honda

9 Modules of TASK EQ 2D Equilibrium Fixed/Free boundary, Toroidal rotation TR 1D Transport Diffusive transport, Transport models WR 3D Geometr. Optics EC, LH: Ray tracing, Beam tracing WM 3D Full Wave IC, AW: Antenna excitation, Eigenmode FP 3D Fokker-Planck Relativistic, Bounce-averaged DP Wave Dispersion Local dielectric tensor, Arbitrary f (u) PL Data Interface Data conversion, Profile database LIB Libraries LIB, MTX, MPI Under Development TX Transport analysis including plasma rotation and E r Collaboration with TOPICS EQU Free boundary equilibrium NBI NBI heating

10 Structure of TASK

11 Inter-Module Collaboration Interface: TASK/PL Role of Module Interface Data exchange between modules: Standard dataset: Specify set of data (cf. ITPA profile DB) Specification of data exchange interface: initialize, set, get Execution control: Specification of execution control interface: initialize, setup, exec, visualize, terminate Uniform user interface: parameter input, graphic output Role of data exchange interface: TASK/PL Keep present status of plasma and device Store history of plasma Save into fileandloadfromfile Interface to experimental data base

12 Standard Dataset (interim) Shot data Machine ID, Shot ID, Model ID Device data: (Level1) RR R m Geometrical major radius RA a m Geometrical minor radius RB b m Wall radius BB B T Vacuum toroidal mag. field RKAP κ Elongation at boundary RDLT δ Triangularity at boundary RIP I p A Typical plasma current Equilibrium data: (Level1) PSI2D ψ p (R, Z) Tm 2 2D poloidal magnetic flux PSIT ψ t (ρ) Tm 2 Toroidal magnetic flux PSIP ψ p (ρ) Tm 2 Poloidal magnetic flux ITPSI I t (ρ) Tm Poloidal current: 2πB φ R IPPSI I p (ρ) Tm Toroidal current PPSI p(ρ) MPa Plasma pressure QINV 1/q(ρ) Inverse of safety factor Metric data 1D: V (ρ), V (ρ), 2D: g ij, 3D: g ij, Fluid plasma data NSMAX s Number of particle species PA A s Atomic mass PZ0 Z 0s Charge number PZ Z s Charge state number PN n s (ρ) m 3 Number density PT T s (ρ) ev Temperature PU u sφ (ρ) m/s Toroidal rotation velocity QINV 1/q(ρ) Inverse of safety factor Kinetic plasma data FP f (p,θ p,ρ) momentum dist. fn at θ = 0 Dielectric tensor data CEPS ɛ (ρ, χ, ζ) Local dielectric tensor Full wave field data CE E(ρ, χ, ζ)v/m Complex wave electric field CB B(ρ, χ, ζ)wb/m 2 Complex wave magnetic field Ray/Beam tracing field data RRAY R(l) m R of ray at length l ZRAY Z(l) m Z of ray at length l PRAY φ(l) rad φ of ray at length l CERAY E(l) V/m Wave electric field at length l PWRAY P(l) W Wave power at length l DRAY d(l) m Beam radius at length l VRAY u(l) 1/m Beam curvature at length l

13 Data Exchange Interface Data structure: Derived type (Fortran95): structured type time plasmaf%time number of grid plasmaf%nrmax e.g. square of grid radius plasmaf%s(nr) plasma density plasmaf%data(nr)%pn plasma temperature plasmaf%data(nr)%pt Program interface e.g. Initialize bpsd init data(ierr) Set data bpsd set data( plasmaf,plasmaf,ierr) Get data bpsd get data( plasmaf,plasmaf,ierr) Other functions: Save data into a file, Load data from a file, Plot data

14 Execution Control Interface Example for TASK/TR TR INIT Initialization (Default value) BPSX INIT( TR ) TR PARM(ID,PSTR) Parameter setup (Namelist input) BPSX PARM( TR,ID,PSTR) TR SETUP(T) Profile setup (Spatial profile, Time) BPSX SETUP( TR,T) TR EXEC(DT) Exec one step (Time step) BPSX EXEC( TR,DT) TR GOUT(PSTR) Plot data (Plot command) BPSX GOUT( TR,PSTR) TR SAVE Save data in file BPSX SAVE( TR ) TR LOAD load data from file BPSX LOAD( TR ) TR TERM Termination BPSX TERM( TR ) Module registration TR STRUCT%INIT=TR INIT TR STRUCT%PARM=TR PARM TR STRUCT%EXEC=TR EXEC BPSX REGISTER( TR,TR STRUCT)

15 Example of data structure: plasmaf type bpsd_plasmaf_data real(8) :: pn! Number density [mˆ-3] real(8) :: pt! Temperature [ev] real(8) :: ptpr! Parallel temperature [ev] real(8) :: ptpp! Perpendicular temperature [ev] real(8) :: pu! Parallel flow velocity [m/s] end type bpsd_plasmaf_data type bpsd_plasmaf_type real(8) :: time integer :: nrmax! Number of radial points integer :: nsmax! Number of particle species real(8), dimension(:), allocatable :: s! (rhoˆ2) : normarized toroidal flux real(8), dimension(:), allocatable :: qinv! 1/q : inverse of safety factor type(bpsd_plasmaf_data), dimension(:,:), allocatable :: data end type bpsd_plasmaf_type

16 Examples of sequence in a module TR EXEC(dt) call bpsd get data( plasmaf,plasmaf,ierr) call bpsd get data( metric1d,metric1d,ierr) local data <- plasmaf,metric1d advance time step dt plasmaf <- local data call bpsd set data( plasmaf,plasmaf,ierr) EQ CALC call bpsd get data( plasmaf,plasmaf,ierr) local data <- plasmaf calculate equilibrium update plasmaf call bpsd set data( plasmaf,plasmaf,ierr) equ1d,metric1d <- local data call bpsd set data( equ1d,equ1d,ierr) call bpsd set data( metric1d,metric1d,ierr)

17 Example: Coupling of TASK/TR and TOPICS/EQU TOPICS/EQU: Free boundary 2D equilibrium TASK/TR Diffusive 1D transport (CDBM + Neoclassical) QUEST parameters: R = 0.64 m, a = 036 m, B = 0.64 T, I p = 300 ka, OH+LHCD ψ p (R, Z) j φ T e (ρ, t) j (ρ, t) psi(r,z) rcu(r,z) TE [kev] vs t AJ [A/m^2] vs t

18 Transport simulation OH + off-axis LHCD: 200 kw Formation of internal transport barrier (equilibrium not solved) PIN,POH,PNB,PRF,PNF,PEX [MW] vs t P OH P TOT P LH WF,WB,WI,WE [MJ] vs t W tot W e TE,TD,<TE>,<TD> [kev] vs t T e (0) T i (0) IPPRL,IOH,INB,IRF,IBS,IP [MA] vs t I OH ILH I BS TE,TD [kev] vs r T e T i AKD,AKNCD,AKDWD [m 2 /s] vs r χ i χ TOT 2 χ NC χ CDBM JTOT,JOH,JNB,JRF,JBS [MA/m 2 ] vs r j OH j BS j LH j TOT QP vs r q

19 Self-Consistent Wave Analysis with Modified f(u) Modification of velocity distribution from Maxwellian Absorption of ICRF waves in the presence of energetic ions Current drive efficiency of LHCD NTM controllability of ECCD (absorption width) Self-consistent wave analysis including modification of f (u)

20 Self-Consistent ICRF Minority Heating Analysis Analysis in TASK Dielectric tensor for arbitrary f (v) Full wave analysis with the dielectric tensor Fokker-Plank analysis of full wave results Self-consistent iterative analysis: Preliminary Energetic ion tail formation Broadening of power deposition profile Momentum Distribution Tail Formation Power deposition PPERP 10 0 F2 FMIN = E+01 FMAX = E P abs with tail Pabs [arb. unit] P abs w/o tail PPARA p**2 r/a

21 FLR Effects in Full Waves Analyses Several approaches to describe the FLR effects. Differential operators: k ρ iρ / r This approach cannot be applied to the case k ρ 1. Extension to the third and higher harmonics is difficult. Spectral method: Fourier transform in inhomogeneous direction This approach can be applied to the case k ρ>1. All the wave field spectra are coupled with each other. Solving a dense matrix equation requires large computer resources. Integral operators: ɛ(x x ) E(x )dx This approach can be applied to the case k ρ>1 Correlations are localized within several Larmor radii Necessary to solve a large band matrix

22 Full Wave Analysis Using an Integral Form of Dielectric Tensor Maxwell s equation: E(r) + ω2 ɛ (r, r c 2 ) E(r )dr = μ 0 j ext (r) Integral form of dielectric tensor: ɛ (r, r ) Integration along the unperturbed cyclotron orbit 1D analysis in tokamaks (in the direction of major radius) To confirm the applicability of an integral form of dielectric tensor Another formulation in the lowest order of ρ/l Sauter O, Vaclavik J, Nucl. Fusion 32 (1992) D analysis in tokamaks In more realistic configurations

23 One-Dimensional Analysis ICRF minoring heating with α-particles (n D : n He = 0.96 : 0.02) Differential form Integral form [V/m] [V/m] Ex Ey Ex Ey R 0 = 3.0m a = 1.2m B 0 = 3T T e0 = 10keV T D0 = 10keV [W/m 2] [W/m 2] PHe T α0 = 3.5MeV PD PHe Pe PD Pe n s0 = m 3 ω/2π = 45MHz Absorption by α may be overestimated by differential approach.

24 2-D Formulation Coordinates Magnetic coordinate system: (ψ, χ, ζ) Local Cartesian coordinate system: (s, p, h) Fourier expansion: poloidal and toroidal mode numbers, m, n Perturbed current j(r, t) = q du qu m dt [ E(r, t ) + u B(r, t ) ] f 0(u ) u The time evolution of χ and ζ due to gyro-motion χ(t τ) = χ(t) + χ v {cos(ω c τ + θ 0 ) cos θ 0 } + χ v {sin(ω c τ + θ 0 ) sin θ 0 } χ s ω c p ω c h v τ ζ(t τ) = ζ(t) + ζ v {cos(ω c τ + θ 0 ) cos θ 0 } + ζ s ω c p v {sin(ω c τ + θ 0 ) sin θ 0 } ζ ω c h v τ

25 Variable Transformations Transformation of Integral Variables Transformation from the velocity space variables (v,θ 0 ) to the particle position s and the guiding center position s 0. ω 2 c Jacobian: J = (v,θ 0 ) (s, s 0 ) = v sin ω c τ. Integration over τ Integral in time calculated by the Fourier series expansion with cyclotron period, 2π/ω c Integration over v Interaction between wave and particles along the magnetic field lines described by the plasma dispersion function.

26 Final Form of Induced Current Induced current: μ 1 1 (ψ) 2 (ψ) = 3 (ψ) J mn J mn J mn du du 0 σ (u, u, u 0 ) 1 (ψ) 2 (ψ) 3 (ψ) E m n E m n E m n Electrical conductivity: ( )7 1 2 σ (u, u q 2, u 0 ) = i n0 2π m Matrix coefficients: m n H 1i = ( ) Q 3 μ 1 1i u Q 1 μ 1 π 2i Z(η l ) + k v T l [ 2π H 2i = ( ) [ Q 2 uμ 1 1i + Q 0 uu μ 1 π 2i Z(η l ) + k v T H 3i = ( Q 2 μ 1 1i + Q 0u ) π μ 1 2i v T v T k Z (η l ) + dχ 2π 0 Q 1v T v 2 μ 1 3i + T dζ exp i { (m m)χ + (n n)ζ } H (u, u,χ) ( 1 v2 T v 2 T ( Q 0 uv T v 2 μ 1 3i T [ Q 0 μ 1 3i + v T v T v T 1 v2 T v 2 T ( ) {Q3 } ] π κ 2i + Q 1 u κ 1i 2 ) 1 v2 T v 2 T 1 k Z (η l ) u { Q 2 κ 2i + Q 0 u κ 1i } ] π 2 1 k Z (η l ) ) {Q2 κ 2i + Q 0 u κ 1i } ] π k η l Z (η l )

27 Kernel functions Q V 2 0 = (u, u,χ 0, l) = ( u + u 2 V 1 = u u 2 V 2 = u u 2 2π 0 exp i ) 2 1 cos λ + 1 tan 1 2 λ u + u 2 1 tan 1 2 λ + u + u 2 Kernel Functions dλ 1 sin λ 1 V 1 V 2 V 1 V 2 [ k v T { (V2 V 1 )cosα (u u )sinα } + lλ V2 0 ω c 2 ( ) u u tan 1 2 λ tan 1 2 λ sin λ h = 1 Jω u s s 0 ω c v T u s s 0 ω c v T 0 n m n 0 i ψ m i ψ 0 where κ = μ 1 g h, μ is the transformation matrix for (s, p, h) (ψ, χ, ζ), and g is the metric tensor. ]

28 Consistent Formulation of Integral Full Wave Analysis Analysis of wave propagation Dielectric tensor: E(r) ω2 c 2 dr 0 dr p f 0 (p, r 0 ) mγ p where r 0 is the gyrocenter position. K 1 (r, r, r 0 ) E(r ) = i ωμ 0 j ext Analysis of modification of momentum distribution function Quasi-linear operator f 0 t + ( ) f0 p E + p dr dr E(r) E(r ) K 2 (r, r, r 0 ) f 0(p, r 0, t) p = ( ) f0 The kernels K 1 and K 2 are closely related and localized in the region r r 0 ρ and r r 0 ρ. p col

29 Extension to TASK/3D 3D Equilibrium: Interface to equilibrium data from VMEC or HINT Interface to neoclassical transport coefficient codes Modules 3D-ready: WR: Ray and beam tracing WM: Full wave analysis Modules to be updated: TR: Diffusive transport (with an appropriate model of E r ) TX: Dynamic transport (with neoclassical toroidal viscosity) Modules to be added: (by Y. Nakamura) EI: Time evolution of current profile in helical geometry

30 Road map of TASK code Present Status In 2 years In 5 years Equlibrium Fixed/Free Boundary Equilibrium Evolution Start Up Analysis Core Transport 1D Diffusive TR Kinetic TR 2D Fluid TR 1D Dynamic TR SOL Transport 2D Fluid TR Plasma-Wall Interaction Neutral Tranport 1D Diffusive TR Orbit Following Energetic Ions Kinetic Evolution Orbit Following Wave Beam Ray/Beam Tracing Beam Propagation Full Wave Kinetic ε Gyro Integral ε Orbit Integral ε Stabilities Sawtooth Osc. Tearing Mode Systematic Stability Analysis ELM Model Resistive Wall Mode Turbulent Transport CDBM Model Linear GK + ZF Nonlinear ZK + ZF Diagnostic Module Control Module

31 Summary We are developing TASK code as a reference core code for integrated burning plasma simulation based on transport analysis. We have developed a part of standard dataset, data exchange interface and execution control and implemented them in TASK code. An example of coupling between TOPICS/EQU and TASK/TR was shown, though not yet completed. Some other modules of TOPICS will be incorporated soon. Preliminary results of self-consistent analysis of wave heating and current drive describing the time evolution of the momentum distribution function and Integro-differential full wave analysis including FLR effects have been obtained. Further continuous development of integrated modeling is needed for comprehensive ITER simulation.

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

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

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 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 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 Tokamak Code: TASK

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

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

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

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

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

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

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

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

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

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

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

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

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

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

Computational Study of Non-Inductive Current Buildup in Compact DEMO Plant with Slim Center Solenoid

Computational Study of Non-Inductive Current Buildup in Compact DEMO Plant with Slim Center Solenoid 1st IAEA TM, First Generation of Fusion Power Plants Design and Technology -, Vienna, July 5-7, 25 Computational Study of Non-Inductive Current Buildup in Compact DEMO Plant with Slim Center Solenoid Y.

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

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

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

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

Development of a Systematic, Self-consistent Algorithm for the K-DEMO Steady-state Operation Scenario

Development of a Systematic, Self-consistent Algorithm for the K-DEMO Steady-state Operation Scenario Development of a Systematic, Self-consistent Algorithm for the K-DEMO Steady-state Operation Scenario J.S. Kang 1, J.M. Park 2, L. Jung 3, S.K. Kim 1, J. Wang 1, D. H. Na 1, C.-S. Byun 1, Y. S. Na 1, and

More information

MHD Stabilization Analysis in Tokamak with Helical Field

MHD Stabilization Analysis in Tokamak with Helical Field US-Japan Workshop on MHD Control, Magnetic Islands and Rotation the University of Texas, Austin, Texas, USA AT&T Executive Education & Conference Center NOVEMBER 3-5, 8 MHD Stabilization Analysis in Tokamak

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

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

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

Non-ohmic ignition scenarios in Ignitor

Non-ohmic ignition scenarios in Ignitor Non-ohmic ignition scenarios in Ignitor Augusta Airoldi IFP, EURATOM-ENEA-CNR Association, Milano, Italy Francesca Bombarda, Giovanna Cenacchi Ignitor Group, ENEA, Italy Bruno Coppi MIT, USA DPP1 APS Meeting

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

POWER DENSITY ABSORPTION PROFILE IN TOKAMAK PLASMA WITH ICRH

POWER DENSITY ABSORPTION PROFILE IN TOKAMAK PLASMA WITH ICRH Dedicated to Professor Oliviu Gherman s 80 th Anniversary POWER DENSITY ABSORPTION PROFILE IN TOKAMAK PLASMA WITH ICRH N. POMETESCU Association EURATOM-MECTS Romania, University of Craiova, Faculty of

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

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

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

- 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

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

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

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

ICRF Minority-Heated Fast-Ion Distributions on the Alcator C-Mod: Experiment and Simulation

ICRF Minority-Heated Fast-Ion Distributions on the Alcator C-Mod: Experiment and Simulation ICRF Minority-Heated Fast-Ion Distributions on the Alcator C-Mod: Experiment and Simulation A. Bader 1, P. Bonoli 1, R. Granetz 1, R.W. Harvey 2, E.F. Jaeger 3, R. Parker 1, S. Wukitch 1. 1)MIT-PSFC, Cambridge,

More information

Time-domain simulation and benchmark of LHCD experiment at ITER relevant parameters

Time-domain simulation and benchmark of LHCD experiment at ITER relevant parameters Time-domain simulation and benchmark of LHCD experiment at ITER relevant parameters S. Shiraiwa, P. Bonoli, F. Poli 1, R. W, Harvey 2, C. Kessel 1, R. Parker, and G. Wallace MIT-PSFC, PPPL 1, and CompX

More information

Simulation of alpha particle current drive and heating in spherical tokamaks

Simulation of alpha particle current drive and heating in spherical tokamaks Simulation of alpha particle current drive and heating in spherical tokamaks R. Farengo 1, M. Zarco 1, H. E. Ferrari 1, 1 Centro Atómico Bariloche and Instituto Balseiro, Argentina. Consejo Nacional de

More information

Performance limits. Ben Dudson. 24 th February Department of Physics, University of York, Heslington, York YO10 5DD, UK

Performance limits. Ben Dudson. 24 th February Department of Physics, University of York, Heslington, York YO10 5DD, UK Performance limits Ben Dudson Department of Physics, University of York, Heslington, York YO10 5DD, UK 24 th February 2014 Ben Dudson Magnetic Confinement Fusion (1 of 24) Previously... In the last few

More information

Control of Sawtooth Oscillation Dynamics using Externally Applied Stellarator Transform. Jeffrey Herfindal

Control of Sawtooth Oscillation Dynamics using Externally Applied Stellarator Transform. Jeffrey Herfindal Control of Sawtooth Oscillation Dynamics using Externally Applied Stellarator Transform Jeffrey Herfindal D.A. Ennis, J.D. Hanson, G.J. Hartwell, S.F. Knowlton, X. Ma, D.A. Maurer, M.D. Pandya, N.A. Roberds,

More information

TH/P6-08. CompX, Del Mar, CA 92014, USA; 2Xcel Engineering, Oak Ridge, TN 37830, USA; 3PSFC-MIT,Cambridge, MA 02139

TH/P6-08. CompX, Del Mar, CA 92014, USA; 2Xcel Engineering, Oak Ridge, TN 37830, USA; 3PSFC-MIT,Cambridge, MA 02139 1 Differences Between QL and Exact Ion Cyclotron Resonant Diffusion R.W. Harvey1, Yu. V. Petrov1, E.F. Jaeger2, P.T. Bonoli3, A. Bader3, and RF-SciDAC Group 1 CompX, Del Mar, CA 92014, USA; 2Xcel Engineering,

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

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

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

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

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

Improved RF Actuator Schemes for the Lower Hybrid and the Ion Cyclotron Range of Frequencies in Reactor-Relevant Plasmas

Improved RF Actuator Schemes for the Lower Hybrid and the Ion Cyclotron Range of Frequencies in Reactor-Relevant Plasmas Improved RF Actuator Schemes for the Lower Hybrid and the Ion Cyclotron Range of Frequencies in Reactor-Relevant Plasmas P. T. Bonoli*, S. G. Baek, B. LaBombard, K. Filar, M. Greenwald, R. Leccacorvi,

More information

Analysis of Ion Cyclotron Heating Issues for ITER

Analysis of Ion Cyclotron Heating Issues for ITER 1 TH/P6-8 Analysis of Ion Cyclotron Heating Issues for ITER L.A. Berry 1), D.B. Batchelor 1), P.T. Bonoli 2), M.D. Carter 1), M. Choi 3), W.A. Houlberg 1), D.A. D Ippolito 4), R.W. Harvey 5), E.F. Jaeger

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

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

Toroidal confinement devices

Toroidal confinement devices Toroidal confinement devices Dr Ben Dudson Department of Physics, University of York, Heslington, York YO10 5DD, UK 24 th January 2014 Dr Ben Dudson Magnetic Confinement Fusion (1 of 20) Last time... Power

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

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

Theory for Neoclassical Toroidal Plasma Viscosity in a Toroidally Symmetric Torus. K. C. Shaing

Theory for Neoclassical Toroidal Plasma Viscosity in a Toroidally Symmetric Torus. K. C. Shaing Theory for Neoclassical Toroidal Plasma Viscosity in a Toroidally Symmetric Torus K. C. Shaing Plasma and Space Science Center, and ISAPS, National Cheng Kung University, Tainan, Taiwan 70101, Republic

More information

Modelling of JT-60U Detached Divertor Plasma using SONIC code

Modelling of JT-60U Detached Divertor Plasma using SONIC code J. Plasma Fusion Res. SERIES, Vol. 9 (2010) Modelling of JT-60U Detached Divertor Plasma using SONIC code Kazuo HOSHINO, Katsuhiro SHIMIZU, Tomonori TAKIZUKA, Nobuyuki ASAKURA and Tomohide NAKANO Japan

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

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

Highlights from (3D) Modeling of Tokamak Disruptions

Highlights from (3D) Modeling of Tokamak Disruptions Highlights from (3D) Modeling of Tokamak Disruptions Presented by V.A. Izzo With major contributions from S.E. Kruger, H.R. Strauss, R. Paccagnella, MHD Control Workshop 2010 Madison, WI ..onset of rapidly

More information

Plasma-neutrals transport modeling of the ORNL plasma-materials test stand target cell

Plasma-neutrals transport modeling of the ORNL plasma-materials test stand target cell Plasma-neutrals transport modeling of the ORNL plasma-materials test stand target cell J.M. Canik, L.W. Owen, Y.K.M. Peng, J. Rapp, R.H. Goulding Oak Ridge National Laboratory ORNL is developing a helicon-based

More information

Electron Bernstein Wave (EBW) Physics In NSTX and PEGASUS

Electron Bernstein Wave (EBW) Physics In NSTX and PEGASUS Electron Bernstein Wave (EBW) Physics In NSTX and PEGASUS G. Taylor 1, J.B. Caughman 2, M.D. Carter 2, S. Diem 1, P.C. Efthimion 1, R.W. Harvey 3, J. Preinhaelter 4, J.B. Wilgen 2, T.S. Bigelow 2, R.A.

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

EXC/P2-02. Experiments and Simulations of ITER-like Plasmas in Alcator C-Mod

EXC/P2-02. Experiments and Simulations of ITER-like Plasmas in Alcator C-Mod EXC/P2-02 Experiments and Simulations of ITER-like Plasmas in Alcator C-Mod J. R. Wilson 1, C. E. Kessel 1, S. Wolfe 2, I. Hutchinson 2, P. Bonoli 2, C. Fiore 2, A. Hubbard 2, J. Hughes 2, Y. Lin 2, Y.

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

Ray Tracing and Full-wave Simulation of KSTAR LH Wave

Ray Tracing and Full-wave Simulation of KSTAR LH Wave Ray Tracing and Full-wave Simulation of KSTAR LH Wave 2016 KO-JA Workshop on Physics and Technology of Heating and Current Drive Presented by Young-soon Bae NFRI a W. Namkung, a M.H. Cho, b S. Shiraiwa,

More information

Simulation Study of High-Frequency Magnetosonic Waves Excited by Energetic Ions in Association with Ion Cyclotron Emission )

Simulation Study of High-Frequency Magnetosonic Waves Excited by Energetic Ions in Association with Ion Cyclotron Emission ) Simulation Study of High-Frequency Magnetosonic Waves Excited by Energetic Ions in Association with Ion Cyclotron Emission ) Mieko TOIDA 1),KenjiSAITO 1), Hiroe IGAMI 1), Tsuyoshi AKIYAMA 1,2), Shuji KAMIO

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

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

Overview of edge modeling efforts for advanced divertor configurations in NSTX-U with magnetic perturbation fields

Overview of edge modeling efforts for advanced divertor configurations in NSTX-U with magnetic perturbation fields Overview of edge modeling efforts for advanced divertor configurations in NSTX-U with magnetic perturbation fields H. Frerichs, O. Schmitz, I. Waters, G. P. Canal, T. E. Evans, Y. Feng and V. Soukhanovskii

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

Heating and Current Drive by Electron Cyclotron Waves in JT-60U

Heating and Current Drive by Electron Cyclotron Waves in JT-60U EX/W- Heating and Current Drive by Electron Cyclotron Waves in JT-6U T. Suzuki ), S. Ide ), C. C. Petty ), Y. Ikeda ), K. Kajiwara ), A. Isayama ), K. Hamamatsu ), O. Naito ), M. Seki ), S. Moriyama )

More information

Dependence of Achievable β N on Discharge Shape and Edge Safety Factor in DIII D Steady-State Scenario Discharges

Dependence of Achievable β N on Discharge Shape and Edge Safety Factor in DIII D Steady-State Scenario Discharges Dependence of Achievable β N on Discharge Shape and Edge Safety Factor in DIII D Steady-State Scenario Discharges by J.R. Ferron with T.C. Luce, P.A. Politzer, R. Jayakumar, * and M.R. Wade *Lawrence Livermore

More information

Finite-Orbit-Width Effect and the Radial Electric Field in Neoclassical Transport Phenomena

Finite-Orbit-Width Effect and the Radial Electric Field in Neoclassical Transport Phenomena 1 TH/P2-18 Finite-Orbit-Width Effect and the Radial Electric Field in Neoclassical Transport Phenomena S. Satake 1), M. Okamoto 1), N. Nakajima 1), H. Sugama 1), M. Yokoyama 1), and C. D. Beidler 2) 1)

More information

Effects of stellarator transform on sawtooth oscillations in CTH. Jeffrey Herfindal

Effects of stellarator transform on sawtooth oscillations in CTH. Jeffrey Herfindal Effects of stellarator transform on sawtooth oscillations in CTH Jeffrey Herfindal D.A. Ennis, J.D. Hanson, G.J. Hartwell, E.C. Howell, C.A. Johnson, S.F. Knowlton, X. Ma, D.A. Maurer, M.D. Pandya, N.A.

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

Observations of Counter-Current Toroidal Rotation in Alcator C-Mod LHCD Plasmas

Observations of Counter-Current Toroidal Rotation in Alcator C-Mod LHCD Plasmas 1 EX/P5-4 Observations of Counter-Current Toroidal Rotation in Alcator C-Mod LHCD Plasmas J.E. Rice 1), A.C. Ince-Cushman 1), P.T. Bonoli 1), M.J. Greenwald 1), J.W. Hughes 1), R.R. Parker 1), M.L. Reinke

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

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

Active MHD Control Needs in Helical Configurations

Active MHD Control Needs in Helical Configurations Active MHD Control Needs in Helical Configurations M.C. Zarnstorff 1 Presented by E. Fredrickson 1 With thanks to A. Weller 2, J. Geiger 2, A. Reiman 1, and the W7-AS Team and NBI-Group. 1 Princeton Plasma

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

Full-Wave Maxwell Simulations for ECRH

Full-Wave Maxwell Simulations for ECRH Full-Wave Maxwell Simulations for ECRH H. Hojo Plasma Research Center, University of Tsukuba in collaboration with A. Fukuchi, N. Uchida, A. Shimamura, T. Saito and Y. Tatematsu JIFT Workshop in Kyoto,

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

ARIES ACT1 progress & ACT2

ARIES ACT1 progress & ACT2 ARIES ACT1 progress & ACT2 C. Kessel and F. Poli Princeton Plasma Physics Laboratory ARIES Project Meeting, 9/26-27/2012 Wash. DC Outline Temperature and density profile variations at R = 5.5 m in order

More information

ELMs and Constraints on the H-Mode Pedestal:

ELMs and Constraints on the H-Mode Pedestal: ELMs and Constraints on the H-Mode Pedestal: A Model Based on Peeling-Ballooning Modes P.B. Snyder, 1 H.R. Wilson, 2 J.R. Ferron, 1 L.L. Lao, 1 A.W. Leonard, 1 D. Mossessian, 3 M. Murakami, 4 T.H. Osborne,

More information

(a) (b) (0) [kev] 1+Gω E1. T e. r [m] t [s] t = 0.5 s 6.5 MW. t = 0.8 s 5.5 MW 4.5 MW. t = 1.0 s t = 2.0 s

(a) (b) (0) [kev] 1+Gω E1. T e. r [m] t [s] t = 0.5 s 6.5 MW. t = 0.8 s 5.5 MW 4.5 MW. t = 1.0 s t = 2.0 s FORMTION ND COLLPSE OF INTERNL TRNSPORT BRRIER. Fukuyama Department of Nuclear Engineering, Kyoto University, Kyoto K. Itoh National Institute for Fusion Science, Toki, Gifu S.-I. Itoh, M. Yagi Research

More information

Issues in Neoclassical Tearing Mode Theory

Issues in Neoclassical Tearing Mode Theory Issues in Neoclassical Tearing Mode Theory Richard Fitzpatrick Institute for Fusion Studies University of Texas at Austin Austin, TX Tearing Mode Stability in Tokamaks According to standard (single-fluid)

More information

The fast-ion distribution function

The fast-ion distribution function The fast-ion distribution function Source Collisions Orbits RF Losses W. Heidbrink 3 MeV & 14.7 MeV protons Charge Exchange Reactivity σv Complex neutral beam sources are described by a few parameters

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

Full wave simulations of lower hybrid wave propagation in tokamaks

Full wave simulations of lower hybrid wave propagation in tokamaks PSFC/JA-09-18 Full wave simulations of lower hybrid wave propagation in tokamaks J. C. Wright*, P. T. Bonoli*, C. K. Phillips, E. Valeo and R. W. Harvey** *MIT - Plasma Science and Fusion Center Cambridge,

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

INTRODUCTION TO MAGNETIC NUCLEAR FUSION

INTRODUCTION TO MAGNETIC NUCLEAR FUSION INTRODUCTION TO MAGNETIC NUCLEAR FUSION S.E. Sharapov Euratom/CCFE Fusion Association, Culham Science Centre, Abingdon, Oxfordshire OX14 3DB, UK With acknowledgments to B.Alper for use of his transparencies

More information

Overview of Pilot Plant Studies

Overview of Pilot Plant Studies Overview of Pilot Plant Studies and contributions to FNST Jon Menard, Rich Hawryluk, Hutch Neilson, Stewart Prager, Mike Zarnstorff Princeton Plasma Physics Laboratory Fusion Nuclear Science and Technology

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

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

2D full wave analysis of wave structure by TASK/WF2

2D full wave analysis of wave structure by TASK/WF2 17th NEXT (Numerical Experiment of Tokamak) Meeting, University of Tokyo, Kashiwa, Japan, March 15-16, 2012 2D full wave analysis of wave structure by TASK/WF2 Y. Maruyama, A. Fukuyama Department of Nuclear

More information

AN UPDATE ON DIVERTOR HEAT LOAD ANALYSIS

AN UPDATE ON DIVERTOR HEAT LOAD ANALYSIS AN UPDATE ON DIVERTOR HEAT LOAD ANALYSIS T.K. Mau, A. Grossman, A.R. Raffray UC-San Diego H. McGuinness RPI ARIES-CS Project Meeting June 4-5, 5 University of Wisconsin, Madison OUTLINE Divertor design

More information