ETS  \$Id: Doxyfile 2162 2020-02-26 14:16:09Z g2dpc $
 All Classes Files Functions Variables Pages
helena.f90
Go to the documentation of this file.
1 subroutine helena(equilibrium_in, equilibrium_out, in_path, code_parameters)
2 !-----------------------------------------------------------------------
3 !
4 ! main program helena :
5 ! ---------------------
6 !
7 ! - solves the 2d grad-shafranov equation for arbitrary
8 ! continuous plasma boundaries and equilibrium pressure
9 ! and gamma profiles.
10 ! - 2d cubic isoparametric finite elements are used for an accurate
11 ! representation of the solution.
12 ! - the final solution is obtained on a flux surface grid.
13 !
14 !
15 ! program organization :
16 ! ----------------------
17 !
18 ! blockdata : initialize namelist var.
19 ! helena : main program
20 ! initialization : initialize values
21 ! write_parameters : print output unit 20
22 ! gaussian_points : initialize gaussian points
23 ! cubic_polynomials : def. cubic elements
24 ! shape_soloviev : boundary shape soloviev eq.
25 ! (zero) : hgolib routine
26 ! fr_soloviev
27 ! (rft2) : hgolib routine
28 ! shape_analytic
29 ! (gridinv) : hgolib routine
30 ! (rft2)
31 ! node_numbers : initialize element numbering
32 ! initial_grid : def. initial grid
33 ! radb : radial profile of elements
34 ! initkq : init. matrix kk and vector q
35 ! build_matrix : calc. matix kk and vector q
36 ! dp_dpsi : derivative of pressure
37 ! dgamma_dpsi : derivative of gamma
38 ! interpolation : cubic elements interpolation
39 ! bounkq : insert boundary cond.
40 ! interpolation
41 ! delrc : delete rows and columns
42 ! solve : solve matrix equations
43 ! conjgr : conjugate gradients
44 ! shrink : remove rows/columns b.c.
45 ! scale : scale matrix problem
46 ! asub : matrix vector inproduct
47 ! expand : insert rows/columns b.c.
48 ! shrink
49 ! restore : insert b.c. in solution
50 ! find_axis : find magnetic axis
51 ! root : solve quadratic equation
52 ! cubic_interp_1d
53 ! normalize_psi : normalize psi solution
54 ! remesh : calc. new isoparametric mesh
55 ! radial_mesh
56 ! rpack
57 ! drpack
58 ! ddrpack
59 ! thtmima : find minimum theta in elm.
60 ! position : find psi/theta point in elm.
61 ! (c05zaf) : nag routine
62 ! fzero
63 ! interpolation
64 ! (c05pbf) : nag routine
65 ! posbnd : find psi/theta point boundary
66 ! solve_cubic : solve cubic equation
67 ! interpolation
68 ! radial_mesh
69 ! mapping : calc. metric flux coord.
70 ! profiles : eq. profiles
71 ! pressure : pressure
72 ! gamma : gamma
73 ! radial_mesh
74 ! interpolation
75 ! solve_cubic
76 ! diagnostics : calc. beta, betapl
77 !
78 !
79 ! the numbering used for the interpolating functions h :
80 !
81 ! r0,s0
82 ! h h
83 ! h h with i,j = 0 or 1 indicates a derivative
84 ! hhhhhh with respect to r,s. r0 and s0 refer to the
85 ! h h 4 nodes of one element and can be +1. or -1.
86 ! h h
87 ! i,j
88 ! s
89 ! .
90 ! +1 .
91 ! n2----------.-----------n3
92 ! | . |
93 ! | . |
94 ! | . | --> r
95 ! .......-1.|......................|.+1.......
96 ! | . |
97 ! | . |
98 ! | . |
99 ! | . |
100 ! n1----------.-----------n4
101 ! . -1
102 ! .
103 !-----------------------------------------------------------------------
104 
105  use itm_types
106  use mod_parameter
107 
108  use mod_corners
109  use mod_dat
110  use mod_dete
111  use mod_helena_io
112  use mod_map
113  use mod_mesh
114  use mod_meshacc
115  use mod_nodes
116  use mod_output
117  use mod_profiles
118  use mod_solver
119 
120  use mod_equilibrium
126  use phys_profiles
127  use plot_data
128  use mapping_mod
130  use helena_spline
131 
132  use mod_itm
133  use euitm_schemas
134  use euitm_xml_parser
135 
136  implicit none
137 
138 !-- call parameters
139  type (type_equilibrium), pointer :: equilibrium_in(:)
140  type (type_equilibrium), pointer :: equilibrium_out(:)
141  character(len = 132), optional :: in_path
142  type (type_param) :: code_parameters
143 
144  type (type_equilibrium) :: equilibrium
145 
146  type(spline_coefficients) :: p_spline
147 
148  real(r8), parameter :: rel_change_w_mhd = 1.e-2_r8
149  integer(itm_i4), parameter :: max_points_boundary = 1025
150 
151  real(r8), allocatable :: zvol(:), zvolp(:)
152  real(r8), allocatable :: drmerc(:), dimerc(:), hh(:)
153  real(r8), allocatable :: qprof(:), dqprof(:), geonc(:), zjpar(:)
154  real(r8), allocatable :: fcirc(:), b02av(:), b0max(:), rav(:)
155  real(r8), allocatable :: x_work(:), y_work(:), work(:), theta(:)
156  real(r8), allocatable :: fr(:)
157  real(r8), dimension(:), pointer :: frmajor, fz
158  real(r8), allocatable :: dummy1(:)
159  real(r8), allocatable :: pskn1(:) ! Psi in increasing order
160  real(r8), allocatable :: xx_center(:), yy_center(:)
161 
162  real(r8), dimension(3) :: abltg
163 
164  real(r8) :: a, a_input
165  real(r8) :: rminor
166  real(r8) :: rgeo, amin
167  real(r8) :: b0
168  real(r8) :: fscale
169  real(r8) :: sax, rax
170  real(r8) :: xaxis, yaxis, psaxis
171  real(r8) :: cx, cy
172  real(r8) :: sumdq
173  real(r8) :: q95out, q1out
174  real(r8) :: current, mhd_energy, volume
175  real(r8) :: w_mhd_ref = 0._r8, b_ref
176  real(r8) :: pressure
177  integer(itm_i4) :: i, j, m
178  integer(itm_i4) :: nax
179  integer(itm_i4) :: n_bnd
180  integer(itm_i4) :: meshno = 0
181  integer(itm_i4) :: nelm, no, n1, n2, n3, n4
182  integer(itm_i4) :: end_of_path
183 
184  logical :: converged_current = .false.
185  logical :: npts_set = .false.
186  logical :: first
187 
188  integer(itm_i4) :: return_status
189 
190  character(len = 132) :: codename(1) = 'HELENA'
191  character(len = 132) :: codeversion(1) = '325'
192 
193  character(len = 2) :: file_no
194 
195  if (.not. present(in_path)) then
196  path = './' ! run locally
197  else
198  path = in_path
199 !-- determine end of path, defined by zero byte, required because of Kepler
200  end_of_path = index(path, achar(0)) - 1
201  if (end_of_path <= 0) then
202  end_of_path = len_trim(adjustl(path))
203  if (end_of_path == 0) then
204  path = ''
205  else
206  path = trim(adjustl(path))
207  end if
208  else
209  path = trim(adjustl(path(1 : end_of_path)))
210  end if
211  end if
212 
213  write(*, *) 'pre: helena_initialization'
214  !call system('date +%s%N')
215 
216 !-- initialize parameters
218  cpsurfin = 1._r8
219  rminor = 1._r8
220  zgeo = 0._r8
221 
222  write(*, *) 'pre: gaussian_points'
223  !call system('date +%s%N')
224 
225 !-- initialize interpolating functions
226  call gaussian_points
227 
228  write(*, *) 'post: gaussian_points'
229  !call system('date +%s%N')
230 
231 !-- plasma boundary
232  if (associated(equilibrium_in(1)%eqgeometry%boundary(1)%r) &
233  .and. associated(equilibrium_in(1)%eqgeometry%boundary(1)%r)) then
234  frmajor => equilibrium_in(1)%eqgeometry%boundary(1)%r
235  fz => equilibrium_in(1)%eqgeometry%boundary(1)%z
236 !-- find last point in eqgeometry%boundary (may have filling zeros at the end)
237  do n_bnd = size(frmajor), 1, -1
238  if (frmajor(n_bnd) /= 0._r8 .or. fz(n_bnd) /= 0._r8) exit
239  end do
240 !-- remove duplicated point(s) of closed boundary if necessary
241  do
242  if (n_bnd == 1) then
243  write(iu6, *) 'ERROR: boundary has only 1 point'
244  exit
245  end if
246  if (frmajor(1) == frmajor(n_bnd) .and. fz(1) == fz(n_bnd)) then
247  n_bnd = n_bnd - 1
248  write(iu6, *) 'removed duplicated point from boundary'
249  else
250  exit
251  end if
252  end do
253  write(iu6, *) 'n_bnd = ', n_bnd
254  rvac = (maxval(frmajor(1 : n_bnd)) + minval(frmajor(1 : n_bnd))) &
255  / 2._r8
256  rminor = (maxval(frmajor(1 : n_bnd)) - minval(frmajor(1 : n_bnd))) &
257  / 2._r8
258  write(*,*) 'Guessed rvac, rminor = ', rvac, rminor
259  else
260  write(iu6, *) 'ERROR: no plasma boundary specified'
261  stop
262  end if
263 
264 !TODO: The following is a quick-fix for the CEA ETS workflow which needs
265 ! to be checked again
266  if (associated(equilibrium_in(1)%profiles_1d%psi)) then
267  cpsurfin = equilibrium_in(1)%profiles_1d%psi( &
268  size(equilibrium_in(1)%profiles_1d%psi)) &
269  - equilibrium_in(1)%profiles_1d%psi(1)
270  end if
271 
272 !-- save psi on axis or initialize it to zero
273  if (exists_entry(equilibrium_in(1)%global_param%psi_ax)) then
274  psi_axis = equilibrium_in(1)%global_param%psi_ax
275  else
276  psi_axis = 0._r8
277  end if
278 
279 !-- fields which may be overruled by helena.xml
280  if (exists_entry(equilibrium_in(1)%global_param%psi_bound) &
281  .and. exists_entry(equilibrium_in(1)%global_param%psi_ax)) then
282  cpsurfin = (equilibrium_in(1)%global_param%psi_bound &
283  - equilibrium_in(1)%global_param%psi_ax)
284  else
285  if (associated(equilibrium_in(1)%profiles_1d%psi)) then
286  equilibrium_in(1)%global_param%psi_ax &
287  = equilibrium_in(1)%profiles_1d%psi(1)
288  equilibrium_in(1)%global_param%psi_bound &
289  = equilibrium_in(1)%profiles_1d%psi(size( &
290  equilibrium_in(1)%profiles_1d%psi))
291  end if
292  end if
293  if (exists_entry(equilibrium_in(1)%eqgeometry%geom_axis%r)) &
294  rvac = equilibrium_in(1)%eqgeometry%geom_axis%r
295  if (exists_entry(equilibrium_in(1)%eqgeometry%a_minor)) &
296  rminor = equilibrium_in(1)%eqgeometry%a_minor
297  eps = rminor / rvac
298  if (exists_entry(equilibrium_in(1)%global_param%mag_axis%bphi)) &
299  bvac = equilibrium_in(1)%global_param%mag_axis%bphi
300  if (exists_entry(equilibrium_in(1)%global_param%toroid_field%r0) &
301  .and. exists_entry(equilibrium_in(1)%global_param%toroid_field%b0)) &
302  bvac = equilibrium_in(1)%global_param%toroid_field%r0 &
303  * equilibrium_in(1)%global_param%toroid_field%b0 / rvac
304  if (exists_entry(equilibrium_in(1)%global_param%i_plasma)) &
305  ip = equilibrium_in(1)%global_param%i_plasma
306 
307  allocate(equilibrium_out(1))
308  allocate(equilibrium_out(1)%codeparam%codename(1))
309  allocate(equilibrium_out(1)%codeparam%codeversion(1))
310  if (.not. associated(code_parameters%parameters)) then
311  write(iu6, *) 'ERROR: code parameters not associated!'
312  stop
313  else
314  allocate(equilibrium_out(1)%codeparam%parameters(size( &
315  code_parameters%parameters)))
316  end if
317 
318 !-- add to equilibrium_out
319  equilibrium_out(1)%datainfo%cocos = 13
320  equilibrium_out(1)%codeparam%codename = codename
321  equilibrium_out(1)%codeparam%codeversion = codeversion
322  equilibrium_out(1)%codeparam%parameters = code_parameters%parameters
323 
324  write(*, *) 'pre: helena_assign_code_parameters'
325  !call system('date +%s%N')
326 
327 !-- assign code parameters to internal variables
328  call helena_assign_code_parameters(code_parameters, return_status)
329 
330  if (return_status /= 0) then
331  write(iu6, *) 'ERROR: Could not assign code parameters.'
332  return
333  end if
334 
335 !-- define r0 if not defined
336  if (exists_entry(equilibrium_in(1)%global_param%toroid_field%r0)) then
337  r_vessel = equilibrium_in(1)%global_param%toroid_field%r0
338  else
339  r_vessel = rvac
340  end if
341 
342  if (trim(match) == "Ip" .and. ip == 0._r8) then
343  write(iu6, *) "Error: for match == 'Ip' the total current must be" &
344  // "specified"
345  stop
346  end if
347 
348  if (verbosity > 0) then
349  write(iu6, *) '******************************************************'
350  write(iu6, *) '* HELENA *'
351  write(iu6, *) '******************************************************'
352  end if
353 
354  if (verbosity > 0) write(iu6, *) 'done assigning code parameters'
355 
356 !-- create run directory
357  if (output /= 'none' .and. (standard_output .or. elite_output &
358  .or. profiles_output .or. additional_output .or. xmgrace_output)) then
359  call system('mkdir -p ' // trim(adjustl(path)))
360  write(iu6, *) 'created run directory'
361  end if
362 
363 !-- create plot directory
364  if (xmgrace_output) then
365  call system('mkdir -p ' // trim(adjustl(path)) // 'plots')
366  write(iu6, *) 'created plots directory'
367  end if
368 
369 !-- consistency checks
370 
371  if (ias == 1 .and. mod(nchi, 2) /= 0) then
372  write(iu6, *) 'Error: nchi must be 2^n'
373  stop
374  end if
375  if (ias == 0 .and. mod(nchi, 2) /= 1) then
376  write(iu6, *) 'Error: nchi must be 2^n + 1'
377  stop
378  end if
379 
380  if (n_acc_points < 0 .or. n_acc_points > 10) then
381  write(iu6, *) 'Error: condition 0 <= n_acc_points <= 10 not fulfilled!'
382  stop
383  end if
384  if (equidistant < 0 .or. equidistant > 1) then
385  write(iu6, *) 'Error: condition 0 <= equidistant <= 1 not fulfilled!'
386  stop
387  end if
388 
389  if (te%shape > 2) then
390  write(iu6, *) 'Error: 0 <= te%shape <= 2 !'
391  stop
392  end if
393  if (ne%shape > 2) then
394  write(iu6, *) 'Error: 0 <= ne%shape <= 2 !'
395  stop
396  end if
397 
398  if (wmhd < 0._r8) then
399  write(iu6, *) 'Error: wmhd must be positive !'
400  stop
401  end if
402 
403  if (verbosity > 1) then
404  write(iu6, *) 'cpsurfin ', cpsurfin
405  write(iu6, *) 'rvac ', rvac
406  write(iu6, *) 'rminor ', rminor
407  write(iu6, *) 'eps ', eps
408  write(iu6, *) 'bvac ', bvac
409  end if
410 
411  if (verbosity > 2) then
412  write(iu6, *) 'W_MHD = ', wmhd
413  write(iu6, *) 'mfm = ', mfm
414  end if
415 
416  i = 2
417  do
418  if (mfm < i) then
419  write(iu6, *) 'ERROR: mfm not a power of 2'
420  return
421  end if
422  if (mfm == i) exit
423  i = i * 2
424  end do
425 
426  write(*, *) 'pre: shape'
427  !call system('date +%s%N')
428 
429 !-- mfm is the number of points specifying the boundary and at the same
430 ! time the number of Fourier components
431 ! i.e. mharm = mfm / 2 is the number of Fourier harmonics
432  mharm = mfm / 2
433 
434  allocate(fr(mfm + 2))
435  fr = 0._r8
436 !-- calculate radii from boundary
437  if (verbosity > 1) write(iu6, *) 'shape from discrete points'
438  call shape_from_points(frmajor(1: n_bnd), fz(1 : n_bnd), n_bnd, mfm, rgeo, &
439  amin, fr)
440  fr = fr / amin ! normalize to minor radius of input boundary
441 !-- Rgeo is discarded and replaced by rvac, while Zgeo is kept since
442 ! vertical shifts do not affect the equilibrium
443 
444  allocate(theta(mfm))
445 
446  do m = 1, mfm
447  theta(m) = 2._r8 * pi * (m - 1) / dble(mfm - 1)
448  end do
449 
450  if (xmgrace_output) then
451  call plot_data_1d('line', theta, fr, mfm, 'xmgr_boundary_orig')
452  end if
453 
454  deallocate(theta)
455 
456 !-- Fourier transform of fr(1:mfm) yields mfm Fourier coefficients fr(1:mfm)
457 ! rft2 requires dimension mfm + 2 for fr !
458  call rft2(fr, mfm, 1)
459 
460  do m = 1, mfm
461  fr(m) = 2._r8 * fr(m) / dble(mfm)
462  end do
463  do m = 2, mfm, 2
464  fr(m) = -fr(m) ! invert sign of imaginary coefficients
465  end do
466 
467  call fourier_backtransform(fr, mfm)
468 
469  write(*, *) 'post: shape'
470  !call system('date +%s%N')
471 
472 !-- calculate constants
473  rminor = eps * rvac
474  if (verbosity > 2) write(iu6, *) 'minor radius a = ', rminor
475 
476  if (standard_output) &
477  open (unit = out_he, file = trim(adjustl(path)) // file_he_out, &
478  status = 'replace', form = 'formatted', action = 'write', iostat = i_error)
479 
480 !-- soloviev settings
481  if (isol == 1) then
482  a = 2._r8 * (1._r8 + (1._r8 - eps**2 / 4._r8) / ellip**2)
483  b = 2._r8 * eps + tria / ellip**2 / (1._r8 + (1._r8 - eps**2 &
484  / 4._r8) / ellip**2)
485  cpsurf = 0.5_r8 * eps**2 / (1._r8 + eps**2)**2 * ellip &
486  / sqrt(1._r8 - eps**2 / 4._r8)
487  radius = sqrt(eps**2 / (1._r8 + eps**2))
488  b0 = sqrt(1._r8 + eps**2)
489  alfa = radius**2 * b0 / cpsurf
490  niter = 1
491  end if
492 
493  txtout(1) = ' '
494 
495 !-- extract fixed fields from equilibrium_in
496 
497 !-- 1D profiles
498  if (associated(equilibrium_in(1)%profiles_1d%pprime)) then
499  if (verbosity > 1) write(iu6, *) 'pprime specified on input'
500  npts_set = .true.
501  npts = size(equilibrium_in(1)%profiles_1d%pprime)
502  allocate(dp(npts))
503  dp = equilibrium_in(1)%profiles_1d%pprime
504  end if
505  if (associated(equilibrium_in(1)%profiles_1d%pressure)) then
506  if (npts_set .and. size(equilibrium_in(1)%profiles_1d%pressure) &
507  /= npts) then
508  write(iu6, *) 'ERROR: input profiles have inconsistent sizes'
509  stop
510  else
511  if (verbosity > 1) write(iu6, *) 'pressure specified on input'
512  npts_set = .true.
513  npts = size(equilibrium_in(1)%profiles_1d%pressure)
514  p_sep = equilibrium_in(1)%profiles_1d%pressure(npts)
515  end if
516  else
517  p_sep = 0._r8
518  end if
519  if (associated(equilibrium_in(1)%profiles_1d%ffprime)) then
520  if (npts_set .and. size(equilibrium_in(1)%profiles_1d%ffprime) &
521  /= npts) then
522  write(iu6, *) 'ERROR: input profiles have inconsistent sizes'
523  stop
524  else
525  if (verbosity > 1) write(iu6, *) 'ffprime specified on input'
526  npts_set = .true.
527  npts = size(equilibrium_in(1)%profiles_1d%ffprime)
528  allocate(fdf(npts))
529  fdf = equilibrium_in(1)%profiles_1d%ffprime
530  end if
531  end if
532  if (associated(equilibrium_in(1)%profiles_1d%jphi)) then
533  if (npts_set .and. size(equilibrium_in(1)%profiles_1d%jphi) &
534  /= npts) then
535  write(iu6, *) 'ERROR: input profiles have inconsistent sizes'
536  stop
537  else
538  if (verbosity > 1) write(iu6, *) 'j_tor specified on input'
539  npts_set = .true.
540  npts = size(equilibrium_in(1)%profiles_1d%jphi)
541  allocate(j_tor(npts))
542  j_tor = equilibrium_in(1)%profiles_1d%jphi
543  end if
544  end if
545  if (associated(equilibrium_in(1)%profiles_1d%q)) then
546  if (npts_set .and. size(equilibrium_in(1)%profiles_1d%q) &
547  /= npts) then
548  write(iu6, *) 'ERROR: input profiles have inconsistent sizes'
549  stop
550  else
551  if (verbosity > 1) write(iu6, *) 'q specified on input'
552  npts_set = .true.
553  npts = size(equilibrium_in(1)%profiles_1d%q)
554  allocate(q_in(npts))
555  q_in = equilibrium_in(1)%profiles_1d%q
556  end if
557  end if
558 
559  if (.not. npts_set) then
560  write(iu6, *) 'fatal error: no input profiles specified'
561  stop
562  end if
563 
564  if (associated(equilibrium_in(1)%profiles_1d%psi)) then
565  if (npts_set .and. size(equilibrium_in(1)%profiles_1d%psi) &
566  /= npts) then
567  write(iu6, *) 'ERROR: input profiles have inconsistent sizes'
568  stop
569  else
570  if (verbosity > 1) write(iu6, *) 'psi specified on input'
571  npts_set = .true.
572  npts = size(equilibrium_in(1)%profiles_1d%psi)
573  allocate(psi_in(npts))
574  if (equilibrium_in(1)%profiles_1d%psi(1) /= 0._r8) then
575  if (verbosity > 2) write(iu6, *) 'psi shifted to be 0 on axis'
576  end if
577  psi_in = (equilibrium_in(1)%profiles_1d%psi &
578  - equilibrium_in(1)%profiles_1d%psi(1))
579  end if
580  else
581 !TODO: improve this initial assumption for cases with rho_tor or
582 ! rho_vol specifications
583  if (verbosity >1) then
584  write(iu6, *) 'no psi specified on input'
585  write(iu6, *) 'assuming equidistant psi'
586  end if
587  allocate(psi_in(npts))
588  do i = 1, npts
589  psi_in(i) = dble(i - 1) / dble(npts - 1) * cpsurfin
590  end do
591  end if
592 
593  if (.not. associated(equilibrium_in(1)%profiles_1d%psi)) &
594  allocate(equilibrium_in(1)%profiles_1d%psi(npts))
595 
596 !-- re-set input psi
597  equilibrium_in(1)%profiles_1d%psi = psi_in
598 
599 !-- interpolate input p on input psi to determine derivative dp/dpsi if
600 ! input_type == "p and j_tor"
601  if (trim(input_type) == "p and j_tor") then
602  call allocate_spline_coefficients(p_spline, npts)
603  call spline(npts, psi_in, equilibrium_in(1)%profiles_1d%pressure, &
604  0._r8, 0._r8, 2, p_spline)
605  if (.not. associated(equilibrium_in(1)%profiles_1d%pprime)) &
606  allocate(equilibrium_in(1)%profiles_1d%pprime(npts))
607  do i = 1, npts
608  pressure = spwert(npts, psi_in(i), p_spline, psi_in, abltg, 1)
609  equilibrium_in(1)%profiles_1d%pprime(i) = abltg(1)
610  end do
611  call deallocate_spline_coefficients(p_spline)
612  if (verbosity > 2) &
613  write(iu6, *) "interpolated p to derive p'"
614  end if
615 
616 !-- xmgr output of input fields
617  if (xmgrace_output) then
618  if (associated(equilibrium_in(1)%profiles_1d%pprime)) &
619  call plot_data_1d('line', psi_in, equilibrium_in(1)%profiles_1d%pprime, npts, &
620  'xmgr_input_pprime')
621  if (associated(equilibrium_in(1)%profiles_1d%pressure)) &
622  call plot_data_1d('line', psi_in, equilibrium_in(1)%profiles_1d%pressure, npts, &
623  'xmgr_input_pressure')
624  if (associated(equilibrium_in(1)%profiles_1d%ffprime)) &
625  call plot_data_1d('line', psi_in, equilibrium_in(1)%profiles_1d%ffprime, npts, &
626  'xmgr_input_ffprime')
627  if (associated(equilibrium_in(1)%profiles_1d%jphi)) &
628  call plot_data_1d('line', psi_in, equilibrium_in(1)%profiles_1d%jphi, npts, &
629  'xmgr_input_jphi')
630  if (associated(equilibrium_in(1)%profiles_1d%q)) &
631  call plot_data_1d('line', psi_in, equilibrium_in(1)%profiles_1d%q, npts, &
632  'xmgr_input_q')
633  end if
634 
635  write(*, *) 'pre: profiles'
636  !call system('date +%s%N')
637 
638 !-- allocate missing fields
639  if (.not. allocated(fdf)) allocate(fdf(npts))
640 
641 !-- allocate arrays
642  allocate(zvol(nrmap))
643  allocate(zvolp(nrmap))
644 
645  allocate(psivec(npts))
646  allocate(dpres(npts))
647  allocate(p_int(npts))
648  allocate(dgam(npts))
649  allocate(gam_int(npts))
650 
651  call allocate_spline_coefficients(dp_spline, npts)
652  call allocate_spline_coefficients(gam_spline, npts)
653  call allocate_spline_coefficients(j_spline, npts)
654 
655 !-- define psivec as normalized psi_in
656  if (psi_in(1) /= 0._r8) then
657  write(iu6, *) 'fatal error: psi on axis must be zero'
658  stop
659  end if
660  psivec = psi_in / psi_in(npts)
661 
662 !-- set profiles dpres and dgam
663  dpres = equilibrium_in(1)%profiles_1d%pprime
664  if (trim(input_type) == "p' and FF'") then
665  dgam = equilibrium_in(1)%profiles_1d%ffprime
666  end if
667 
668 !-- spline profiles
669  call spline(npts, psivec, dpres, 0._r8, 0._r8, 2, dp_spline)
670  if (trim(input_type) == "p' and FF'") then
671  call spline(npts, psivec, dgam, 0._r8, 0._r8, 2, gam_spline)
672  end if
673  if (allocated(j_tor)) &
674  call spline(npts, psivec, j_tor, 0._r8, 0._r8, 2, j_spline)
675 
676 !-- integrate profiles
677  p_int = integrate(dp_spline, psivec, npts, .true.) &
678  * sign(1.0_r8, cpsurfin)
679  if (trim(input_type) == "p' and FF'") then
680  gam_int = integrate(gam_spline, psivec, npts, .true.) &
681  * sign(1.0_r8, cpsurfin)
682  end if
683 
684 !-- initialize a based on gamma on axis
685  if (trim(input_type) == "p' and FF'") then
686  a = -dgam(1) * (twopi * eps * rvac)**2 / cpsurfin
687  else
688  a = 4
689  end if
690  if (verbosity > 2) write(iu6, *) 'initial a = ', a
691  a_input = a
692 
693 !-- initialize alfa if it hasn't been specified on input
694  if (alfa == 0._r8) &
695  alfa = twopi * (eps * rvac)**2 * bvac / cpsurfin
696  if (verbosity > 2) write(iu6, *) 'initial alfa = ', alfa
697 
698 !-- initial pressure profile, ffprime, and f^2 profiles
699  if (xmgrace_output) then
700  call plot_data_1d('line', psivec, dpres, npts, 'xmgr_initial_dp_psipol')
701  call plot_data_1d('line', psivec, p_int, npts, &
702  'xmgr_initial_p_psipol')
703  if (trim(input_type) == "p' and FF'") then
704  allocate(work(npts))
705  call plot_data_1d('line', psivec, dgam, npts, &
706  'xmgr_initial_ffprime_psipol')
707  work = 2._r8 * gam_int
708  call plot_data_1d('line', psivec, work, npts, 'xmgr_initial_f2_psipol')
709 !-- attention: since gam_int has wrong magnitude due to normalized psivec
710 ! (rvac * bvac)**2 + work may be negative => use abs
711  work = sqrt(abs((rvac * bvac)**2 + work)) * sign(1.0_r8, bvac)
712  call plot_data_1d('line', psivec, work, npts, &
713  'xmgr_initial_rbphi_psipol')
714  deallocate(work)
715  end if
716  end if
717 
718  write(*, *) 'pre: equilibrium constructor'
719  !call system('date +%s%N')
720 
721 !-- construct equilibrium
722  call equilibrium_constructor(equilibrium, nr, nchi)
723 
724 !-- allocate large matrix
725  kklda = 4 * np + 9
726 
727  allocate(kkbig(kklda, 4 * (nr + 2) * np))
728 
729  if (trim(input_type) == "p' and j_tor" &
730  .or. trim(input_type) == "p and j_tor" &
731  .or. trim(input_type) == "p' and q") then
732 !-- no equidistant theta points for initial grid with current iteration
733  iarc = 0
734  end if
735 
736 !-- normalize all profiles
737 
738  if (trim(input_type) == "p' and FF'") then
739  fscale = dgam(1)
740  dgam = dgam / fscale
741  gam_int = gam_int / fscale
742  gam_spline%sp1 = gam_spline%sp1 / fscale
743  gam_spline%sp2 = gam_spline%sp2 / fscale
744  gam_spline%sp3 = gam_spline%sp3 / fscale
745  gam_spline%sp4 = gam_spline%sp4 / fscale
746  end if
747 
748  pscale = dpres(1)
749  dpres = dpres / pscale
750  p_int = p_int / pscale
751  dp_spline%sp1 = dp_spline%sp1 / pscale
752  dp_spline%sp2 = dp_spline%sp2 / pscale
753  dp_spline%sp3 = dp_spline%sp3 / pscale
754  dp_spline%sp4 = dp_spline%sp4 / pscale
755 
756 !-- normalize j_tor to unity on axis (required!)
757  if (trim(input_type) == "p' and j_tor" &
758  .or. trim(input_type) == "p and j_tor" &
759  .or. trim(input_type) == "p' and q") then
760  cscale = j_tor(1)
761  j_tor = j_tor / cscale
762  j_spline%sp1 = j_spline%sp1 / cscale
763  j_spline%sp2 = j_spline%sp2 / cscale
764  j_spline%sp3 = j_spline%sp3 / cscale
765  j_spline%sp4 = j_spline%sp4 / cscale
766  end if
767 
768 !-- if no B specified on input calculate B from pscale and fscale
769 
770  if (b == 0._r8 .and. trim(input_type) == "p' and FF'") then
771  if (verbosity > 1) then
772  write(iu6, *) 'no B specified on input'
773  write(iu6, *) 'automatic calculation of B'
774  end if
775  if (hbt) then
776  b = 2._r8 * eps * mu0 * rvac**2 * pscale / fscale
777  else
778  b = mu0 * rvac**2 * pscale / fscale
779  end if
780  end if
781 
782  if (trim(input_type) == "p' and FF'") then
783  if (verbosity > 2) then
784  write(iu6, *) "================================================="
785  write(iu6, *) "consistency check for input parameter B: "
786  write(iu6, *) "input p'(psi) = dp/dpsi and"
787  write(iu6, *) "F(psi)F'(psi) = 0.5 * dF^2/dpsi"
788  write(iu6, *) "should be in SI units"
789  write(iu6, *) "p'(0) (on input) = ", pscale
790  write(iu6, *) "F(0)F'(0) (on input) = ", fscale
791  if (hbt) then
792  write(iu6, *) "B = ", b, " ?= ", 2._r8 * eps * mu0 * rvac**2 &
793  * pscale / fscale
794  else
795  write(iu6, *) "B = ", b, " ?= ", mu0 * rvac**2 * pscale / fscale
796  end if
797  write(iu6, *) "================================================="
798  end if
799  end if
800 
801  if (standard_output) call write_parameters
802  if (isol == 1) then
803  if (standard_output) then
804  write(out_he, *)
805  write(out_he, *) ' soloviev equilibrium '
806  write(out_he, 2) a
807  write(out_he, 3) b
808  write(out_he, 4) alfa
809  write(out_he, 5) radius
810  write(out_he, 6) b0
811  write(out_he, 7) cpsurf
812  end if
813  txtout(1) = 'soloviev equilibrium'
814  end if
815 !TODO: re-organize verbose output
816  if (standard_output) then
817  write(out_he, *) '******************************************'
818  write(out_he, *) '* input profiles : *'
819  write(out_he, *) '******************************************'
820  if (trim(input_type) == "p' and FF'" .and. .not. hbt) then
821  write(out_he, *) &
822  '* psi, dp/dpsi, FdF/dpsi *'
823  else if (trim(input_type) == "p' and FF'" .and. hbt) then
824  write(out_he, *) &
825  '* psi, dp/dpsi, gamma *'
826  else if (trim(input_type) == "p' and q" .and. hbt) then
827  write(out_he, *) &
828  '* psi, dp/dpsi, gamma, q *'
829  else if (trim(input_type) == "p' and q" .and. .not. hbt) then
830  write(out_he, *) &
831  '* psi, dp/dpsi, FdF/dpsi, q *'
832  else if (trim(input_type) == "p' and j_tor" .and. .not. hbt) then
833  write(out_he, *) &
834  '* psi, dp/dpsi, FdF/dpsi, <j_tor> *'
835  else if (trim(input_type) == "p' and j_tor" .and. hbt) then
836  write(out_he, *) &
837  '* psi, dp/dpsi, gamma, <j_tor> *'
838  else if (trim(input_type) == "p and j_tor" .and. .not. hbt) then
839  write(out_he, *) &
840  '* psi, p, FdF/dpsi, <j_tor> *'
841  else if (trim(input_type) == "p and j_tor" .and. hbt) then
842  write(out_he, *) &
843  '* psi, p, gamma, <j_tor> *'
844  end if
845  write(out_he, *) &
846  '******************************************************'
847  end if
848 
849  write(*, *) 'pre: allocate'
850  !call system('date +%s%N')
851 
852 ! allocate arrays to initial grid size
853  allocate(psi(4 * nr * np))
854  allocate(xx(4, nr * np))
855  allocate(yy(4, nr * np))
856  allocate(xxold(4, nr * np))
857  allocate(yyold(4, nr * np))
858  allocate(psiold(4 * nr * np))
859  allocate(nodeno((nr - 1) * (np - 1), 4))
860 
861  psi = 0._r8
862  xx = 0._r8
863  yy = 0._r8
864  psiold = 0._r8
865  xxold = 0._r8
866  yyold = 0._r8
867 
868  allocate(x_work(nr * np))
869  allocate(y_work(nr * np))
870 
871 !-- allocate solver variables
872  call allocate_solver(nr, np)
873 
874  write(*, *) 'pre: initial grid'
875  !call system('date +%s%N')
876 
877 !-- define initial grid x,y
878  allocate(sg(nr))
879  allocate(dsg(nr))
880  allocate(ddsg(nr))
881  call initial_grid(fr)
882  xaxis = 0._r8 ! initial axis
883 
884  if (xmgrace_output) then
885  x_work = xx(1, 1 : nr * np) * rminor + rvac
886  y_work = yy(1, 1 : nr * np) * rminor
887  call plot_data_1d('2d', x_work, y_work, np, &
888  'xmgr_initial_flux_surfaces_real')
889  call plot_data_1d('2d_t', x_work, y_work, np, &
890  'xmgr_initial_radial_real')
891  call plot_data_1d('grid', x_work, y_work, np, &
892  'xmgr_initial_grid_x_y_real')
893  end if
894 
895  write(*, *) 'pre: node_numbers'
896  !call system('date +%s%N')
897 
898 !-- define numbering of elements
899  call node_numbers
900 
901  write(*, *) 'pre: flxint'
902  !call system('date +%s%N')
903 
904 !-- initialize fdf if input_type /= "p' and FF'"
905  if (trim(input_type) == "p' and j_tor" &
906  .or. trim(input_type) == "p and j_tor" &
907  .or. trim(input_type) == "p' and q") then
908 !-- initialize fdf based on current profile
909  if (trim(input_type) == "p' and j_tor" &
910  .or. trim(input_type) == "p and j_tor") then
911  call flxint(xaxis, a, 0, fscale)
912  else
913 !-- initialize fdf based on q-profile
914  call flxint2(xaxis, a, cx, cy, sumdq)
915  end if
916 
917 !-- re-calculate gam_spline and gam_int after change of fdf (already
918 ! normalized)
919  dgam = fdf
920 !-- spline profiles
921  call spline(npts, psivec, dgam, 0._r8, 0._r8, 2, gam_spline)
922 !-- integrate profiles
923  gam_int = integrate(gam_spline, psivec, npts, .true.)
924  end if
925 
926 !-- allocate and set psikn for the initial grid
927  allocate(psikn(nr))
928  allocate(dpsikn(nr))
929  allocate(ddpsikn(nr))
930  allocate(radpsi(nr))
931  do i = 1, nr
932  psikn(nr - i + 1) = sg(i)**2
933  dpsikn(nr - i + 1) = 2._r8 * sg(i) * dsg(i)
934  ddpsikn(nr - i + 1) = 2._r8 * sg(i) * ddsg(i) + 2._r8 * dsg(i)**2
935  radpsi(nr - i + 1) = dble(i - 1) / dble(nr - 1)
936  end do
937 
938 !-- fill equilibrium for zero order guesses of W_MHD and Ip
939 ! (will differ from the final values since no real equilibrium)
940 ! call fill_equilibrium(a, xaxis, yaxis, current_averaging, equilibrium)
941 
942 !-- needed for update_fdf
943  equilibrium%eqgeometry%geom_axis%r = rvac
944 
945 !-- initial guess for psi for first iteration
946  do i = 1, nr
947  equilibrium%profiles_1d%psi(i) = cpsurfin * psikn(nr + 1 - i)
948  end do
949  equilibrium%profiles_1d%psi(1) = 0._r8
950 
951  write(*, *) 'pre: transfer'
952  !call system('date +%s%N')
953 
954 !-- obsolete ----
955  if (associated(equilibrium_in(1)%profiles_1d%jphi)) then
956  call transfer_1d_profile(psi_in, &
957  equilibrium_in(1)%profiles_1d%jphi, &
958  equilibrium%profiles_1d%psi, equilibrium%profiles_1d%jphi, &
959  spline_type = 1)
960  end if
961  if (associated(equilibrium_in(1)%profiles_1d%pprime)) then
962  call transfer_1d_profile(psi_in, &
963  equilibrium_in(1)%profiles_1d%pprime, &
964  equilibrium%profiles_1d%psi, equilibrium%profiles_1d%pprime, &
965  spline_type = 1)
966  end if
967  if (associated(equilibrium_in(1)%profiles_1d%pressure)) then
968  call transfer_1d_profile(psi_in, &
969  equilibrium_in(1)%profiles_1d%pressure, &
970  equilibrium%profiles_1d%psi, equilibrium%profiles_1d%pressure, &
971  spline_type = 1)
972  end if
973 !----------------
974 
975 !-- calculate W_MHD
976 !TODO: mhd_energy not correct since equilibrium%profiles_1d%pressure not
977 ! defined
978  write(*, *) 'pre: w_mhd'
979  !call system('date +%s%N')
980 
981  if (verbosity > 3) then
982  mhd_energy = w_mhd(equilibrium, rminor, eps)
983  volume = plasma_volume(equilibrium, rminor, eps)
984  write(iu6, *) 'initial W_MHD = ', mhd_energy, ' J'
985  write(iu6, *) 'initial plasma volume = ', volume, ' m^3'
986  end if
987 
988  first = .true.
989 
990 !-- allocated quantities for calls to profiles
991  allocate(p0(nr))
992  allocate(rbphi(nr))
993  allocate(dp0(nr))
994  allocate(drbphi(nr))
995 
996 !---------------------------------------------------------------------------
997 !-- beginning of reference part
998 !---------------------------------------------------------------------------
999 
1000 
1001 !-- initialize old grid before call to p_j_iteration (alternatively call
1002 ! remesh)
1003  xxold = xx
1004  yyold = yy
1005  psiold = psi
1006 
1007  write(*, *) 'pre: p_j'
1008  !call system('date +%s%N')
1009 
1010 !-- loop to adapt <j_tor> and <dp/dpsi>
1011  call p_j_iteration(equilibrium_in(1), equilibrium, first, a, cx, cy, &
1012  psaxis, xaxis, yaxis, nax, rax, sax)
1013 
1014 !TODO: in p_j_iteration: add rescaling of profiles_1d%pprime and
1015 ! profiles_1d%pressure to match plasma beta (if given) or W_MHD
1016 ! (if given)
1017 !-- adapt plasma beta through change of B
1018 ! call betapol(a, bpl)
1019 ! if (betap >= 0._r8 .and. abs(bpl - betap) > 1e-3_r8) then
1020 ! if (nmg == nbb) then
1021 ! b1 = b
1022 ! bp1 = bpl
1023 ! if (b < 0._r8) then
1024 ! if (bpl > betap) then
1025 ! b = 1.02_r8 * b1
1026 ! else
1027 ! b = 0.98_r8 * b1
1028 ! end if
1029 !! b = bpl / (bbb * betap) * b1
1030 ! else
1031 ! b = b1 / bpl * betap
1032 ! end if
1033 ! if (verbosity > 2) write(iu6, '(a18, 2e12.4, a4, e12.4)') &
1034 ! 'first change of b ', b1, bpl, ' >> ', b
1035 ! else
1036 ! if (mod(nmg, nbb) == 0) then
1037 ! bold = b
1038 ! deltab = (b1 - bold) / (bp1 - bpl) * (betap - bpl)
1039 ! if (abs(deltab / bold) > bbb) then
1040 ! b = bold + bbb * deltab / abs(deltab) * abs(bold)
1041 ! else
1042 ! b = bold + abb * (b1 - bold) / (bp1 - bpl) * (betap - bpl)
1043 ! end if
1044 ! if (verbosity > 2) write(iu6, '(a17, 4f12.4, a4, f12.4)') &
1045 ! 'next change of b ', bold, bpl, b1, bp1, ' >> ', b
1046 ! b1 = bold
1047 ! bp1 = bpl
1048 ! end if
1049 ! end if
1050 ! if (verbosity > 1) write(iu6, *) 'betapol'
1051 ! end if
1052 
1053 
1054 !-- re-install old mesh for further iterations (new mesh exists on exit from
1055 ! p_j_iteration)
1056  xx = xxold
1057  yy = yyold
1058  psi = psiold
1059 
1060 !TODO: implement this into p_j_iteration
1061 !-- adapt B after each current iteration if wmhd and j_tor specified,
1062 ! except for last iteration
1063 ! if (verbosity > 1) then
1064 ! write(iu6, *) 'w_mhd_ref = ', w_mhd_ref
1065 ! write(iu6, *) 'mhd_energy = ', mhd_energy
1066 ! end if
1067 ! if (wmhd /= 0._r8 .and. abs(w_mhd_ref - mhd_energy) / w_mhd_ref &
1068 ! > rel_change_W_MHD) then
1069 ! converged_current = .false.
1070 ! if (verbosity > 1) write(iu6, *) 'converged_current = .false.'
1071 ! if (j /= nouter .and. nmg /= nmesh) then
1072 ! B_ref = B
1073 ! if (verbosity > 1) write(iu6, *) 'old B = ', B_ref
1074 ! B = w_mhd_ref / mhd_energy * B
1075 ! if (verbosity > 1) write(iu6, *) 'new B = ', B
1076 ! else
1077 ! if (verbosity > 1) &
1078 ! write(iu6, *) 'warning: current iteration not converged'
1079 ! end if
1080 ! end if
1081 
1082 !-- deallocate solver variables
1083  call deallocate_solver
1084 
1085  first = .true.
1086 
1087 !-- dealllocate arrays
1088  deallocate(kkbig)
1089  deallocate(x_work, y_work)
1090  deallocate(psikn, dpsikn, ddpsikn, radpsi)
1091 
1092  if (verbosity > 2) then
1093  write(iu6, *) "================================================"
1094  write(iu6, *) "consistency check for constrained parameter A: "
1095  write(iu6, *) "A on input = ", a_input
1096  write(iu6, *) "A after final iteration = ", a
1097  write(iu6, *) "================================================"
1098  end if
1099 
1100 !-- remesh on flux coordinates
1101  if (verbosity > 1) write(iu6, *) ' final remesh'
1102 
1103  allocate(psikn(nrmap))
1104  allocate(dpsikn(nrmap))
1105  allocate(ddpsikn(nrmap))
1106  allocate(radpsi(nrmap))
1107 
1108  write(*, *) 'pre: remesh'
1109  !call system('date +%s%N')
1110 
1111  call remesh(a, nrmap, npmap, meshno, cx, cy, xaxis, yaxis, nax, rax, sax)
1112  if (verbosity > 1) write(iu6, *) ' done final remesh'
1113 
1114 !-- fill equilibrium for calculation of W_MHD and Ip
1115  call equilibrium_destructor(equilibrium)
1116  write(*, *) 'pre: fill_equilibrium'
1117  !call system('date +%s%N')
1118  call equilibrium_constructor(equilibrium, nr, nchi)
1119  call fill_equilibrium(a, xaxis, yaxis, current_averaging, equilibrium)
1120 
1121  write(*, *) 'pre: w_mhd'
1122  !call system('date +%s%N')
1123 !-- calculate W_MHD
1124  if (verbosity > 2) then
1125  mhd_energy = w_mhd(equilibrium, rminor, eps)
1126  volume = plasma_volume(equilibrium, rminor, eps)
1127  write(iu6, *) 'W_MHD = ', mhd_energy, ' J'
1128  write(iu6, *) 'plasma volume = ', volume, ' m^3'
1129  end if
1130 
1131  if (xmgrace_output) then
1132  call plot_data_1d('line', equilibrium%profiles_1d%volume, &
1133  equilibrium%profiles_1d%pressure, nr, 'xmgr_p_final')
1134  call plot_data_1d('line', equilibrium%profiles_1d%volume, &
1135  equilibrium%profiles_1d%pprime, nr, 'xmgr_pprime_final')
1136  call plot_data_1d('line', equilibrium%profiles_1d%volume, &
1137  equilibrium%profiles_1d%jphi, nr, 'xmgr_jphi_final')
1138  end if
1139 
1140  deallocate(xxold, yyold, psiold)
1141  deallocate(sg, dsg, ddsg)
1142 
1143  allocate(fcirc(nr))
1144  allocate(b02av(nr))
1145  allocate(b0max(nr))
1146  allocate(rav(nr))
1147 
1148 !TODO: from former current scaling
1149 ! call passing_particles(a, fcirc, b02av, b0max, rav)
1150 
1151 !-- allocate j_tor if not allocated (if j_phi was analytically given)
1152  if (.not. allocated(j_tor)) allocate(j_tor(npts))
1153 
1154  write(*, *) 'pre: rescale alfa'
1155  !call system('date +%s%N')
1156 !-- rescale alfa to input current or input q95
1158  if (trim(match) == "q95") then
1159  if (verbosity > 1) write(iu6, *) ' safety factor', q95
1160  allocate(dummy1(npts))
1161  call safety_factor(xaxis, a, cx, cy, dummy1, q95out, q1out)
1162  deallocate(dummy1)
1163  if (verbosity > 1) write(iu6, *) q1out, q95, alfa
1164  alfa = alfa * q95 / q1out
1165  call total_current(a, xaxis, current)
1166  ip = current
1167  else if (trim(match) == "Ip") then
1168  if (verbosity > 1) write(iu6, *) ' current Ip = ', ip
1169  call total_current(a, xaxis, current)
1170  if (verbosity > 1) write(iu6, *) ' calculated current = ', current
1171  alfa = current / ip
1172  if (verbosity > 1) write(iu6, *) ' alfa : ', alfa
1173  else ! match = "psi_bound"
1174  call total_current(a, xaxis, current)
1175  end if
1176 
1177  write(*, *) 'pre: si_currents'
1178  !call system('date +%s%N')
1179 !-- denormalize currents
1180  call si_currents
1181 
1182  allocate(pskn1(nr))
1183  do i = 1, nr
1184  pskn1(i) = psikn(nr + 1 - i)
1185  end do
1186 
1187 !-- Cartesian coordinates of the geometric centers of each element
1188  allocate(xx_center((nr - 1) * (np - 1)))
1189  allocate(yy_center((nr - 1) * (np - 1)))
1190 !-- because of contouring issues in IDL, the magnetic axis is excluded from
1191 ! the output
1192  no = 0
1193  do i = 2, nr
1194  do j = 1, np -1
1195  no = no + 1
1196  if (i == 1) then
1197  xx_center(no) = xaxis
1198  yy_center(no) = yaxis
1199  else
1200 !-- elements in HELENA are ordered in inverse radial direction, i.e.,
1201 ! psikn(nr) = 0, psikn(1) = 1
1202  nelm = (nr - i) * (np - 1) + j
1203  call set_node_number(nelm, n1, n2, n3, n4)
1204  xx_center(no) = (xx(1, n1) + xx(1, n2) + xx(1, n3) + xx(1, n4)) &
1205  / 4._r8
1206  yy_center(no) = (yy(1, n1) + yy(1, n2) + yy(1, n3) + yy(1, n4)) &
1207  / 4._r8
1208  end if
1209  end do
1210  end do
1211 !-- output currents, averaged over area
1212 
1213  if (xmgrace_output) then
1214  call plot_data_1d('line', pskn1, j_tor_av, nr, 'xmgr_j_tor_av_psi')
1215  call plot_data_1d('line', pskn1, i_tor, nr, 'xmgr_I_tor_psi')
1216  call plot_data_1d('3d', xx_center, yy_center, nr - 1, 'idl_j_tor_loc', &
1217  j_tor_loc)
1218  end if
1219 
1220  deallocate(xx_center, yy_center)
1222 
1223  call deallocate_spline_coefficients(j_spline)
1224  deallocate(j_tor)
1225 
1226  if (xmgrace_output) then
1227  call plot_data_1d('line', abs(equilibrium%profiles_1d%psi), equilibrium%profiles_1d%ffprime, nr, &
1228  'xmgr_resulting_ffprime')
1229  end if
1230 
1231  call write_equidistant_profiles(equilibrium, pskn1, nr)
1232 
1233 !-- j_spline needed in diagnostics only
1234  call allocate_spline_coefficients(j_spline, npts)
1235  allocate(j_tor(npts))
1236  call transfer_1d_profile(pskn1, equilibrium%profiles_1d%jphi, &
1237  psivec, j_tor, spline_type = 1)
1238  call spline(npts, psivec, j_tor, 0._r8, 0._r8, 2, j_spline)
1239 
1240 !-- normalize j_tor
1241  cscale = j_tor(1)
1242  j_tor = j_tor / cscale
1243  j_spline%sp1 = j_spline%sp1 / cscale
1244  j_spline%sp2 = j_spline%sp2 / cscale
1245  j_spline%sp3 = j_spline%sp3 / cscale
1246  j_spline%sp4 = j_spline%sp4 / cscale
1247 
1248  write(*, *) 'pre: diagnostics'
1249  !call system('date +%s%N')
1250 !-- diagnostics
1251  if (verbosity > 3) write(txtout(13), 13) xaxis, yaxis
1252  call diagnostics(a, xaxis, yaxis, zvol, zvolp, current)
1253 !attention: diagnostics recalculates current !!!
1254 
1255  if (verbosity > 2) then
1256  write(iu6, *) &
1257  '-----------------------------------------------------'
1258  write(iu6, *) &
1259  'consistency check for Ip and computed alfa:'
1260  write(iu6, *) &
1261  'current = ',current,', unnormalized current (from Ip) = ', &
1262  ip / 1.e+3_r8, ' kA, alfa = ', alfa
1263  write(iu6, *) &
1264  'current = ',current,', unnormalized current (calculated) = ', &
1265  current / 1.e+3_r8, ' kA, alfa = ',alfa
1266  write(iu6, *) &
1267  '-----------------------------------------------------'
1268  end if
1269 
1270 !TODO: from former current scaling
1271 ! call scale_current(a, rvac, bvac, rav, fcirc, kkk)
1272 
1273  deallocate(fr)
1274 
1275 !-- deallocate profiles
1276  deallocate(p0, rbphi, dp0, drbphi)
1277 
1278 !-- mapping of flux coordinates
1279  allocate(g11_hel(nr, nchi))
1280  allocate(g12_hel(nr, nchi))
1281  allocate(g33_hel(nr, nchi))
1282  allocate(chi(nchi))
1283  allocate(chikn(nchi))
1284  allocate(cs(nr))
1285  allocate(qs(nr))
1286  allocate(dqs(nr))
1287  allocate(p0(nr))
1288  allocate(rbphi(nr))
1289  allocate(dp0(nr))
1290  allocate(drbphi(nr))
1291 
1292  write(*, *) 'pre: mapping'
1293  !call system('date +%s%N')
1294  call equilibrium_constructor(equilibrium_out(1), nr, nchi)
1295  call mapping(cx, cy, xaxis, yaxis, a, equilibrium_out(1))
1296  write(*, *) 'post: mapping'
1297  !call system('date +%s%N')
1298  call current_at_nodes(a, equilibrium_out(1))
1299  if (xmgrace_output) then
1300  call plot_data_2d('3d', equilibrium_out(1)%coord_sys%position%r, &
1301  equilibrium_out(1)%coord_sys%position%z, 'idl_jphi_x_y', &
1302  equilibrium_out(1)%profiles_2d(1)%jphi)
1303  call plot_data_2d('3d', equilibrium_out(1)%coord_sys%position%r, &
1304  equilibrium_out(1)%coord_sys%position%z, 'idl_jpar_x_y', &
1305  equilibrium_out(1)%profiles_2d(1)%jpar)
1306  end if
1307 
1308 !-- deallocate pskn1
1309  deallocate(pskn1)
1310 
1311  write(*, *) 'pre: w_mhd'
1312  !call system('date +%s%N')
1313 !-- calculate W_MHD
1314  if (verbosity > 2) then
1315  mhd_energy = w_mhd(equilibrium_out(1), rminor, eps)
1316  volume = plasma_volume(equilibrium_out(1), rminor, eps)
1317  write(iu6, *) 'W_MHD = ', mhd_energy, ' J'
1318  write(iu6, *) 'plasma volume = ', volume, ' m^3'
1319  end if
1320 
1321 !-- calculate ballooning stability
1322 
1323  allocate(dimerc(nr))
1324  allocate(drmerc(nr))
1325  allocate(hh(nr))
1326  allocate(qprof(nr))
1327  allocate(dqprof(nr))
1328  allocate(geonc(nr))
1329  allocate(zjpar(nr))
1330 
1331  zjpar = 0._r8 ! initialize array
1332 
1333  if (diagnostics_on) then
1334  call mercier(a, dimerc, drmerc, hh, qprof, dqprof, geonc, zjpar)
1335  call suydam_ballooning(equilibrium_out(1), zvol, zvolp, xaxis)
1336  end if
1337 
1338  deallocate(g11_hel, g12_hel, g33_hel)
1339  deallocate(chi, chikn)
1340  deallocate(cs)
1341  deallocate(qs, dqs)
1342  deallocate(p0, dp0, rbphi, drbphi)
1343  deallocate(zvol, zvolp)
1344 
1345  call passing_particles(a, fcirc, b02av, b0max, rav, equilibrium_out(1))
1346 
1347  if (diagnostics_on) then
1348  call si_output(a, rvac, bvac, fcirc, qprof, dqprof, rav, geonc, &
1349  zjpar, dimerc, drmerc, hh, current)
1350  end if
1351 
1352  deallocate(psikn, dpsikn, ddpsikn, radpsi)
1353  deallocate(dimerc, drmerc)
1354  deallocate(hh)
1355  deallocate(dqprof)
1356  deallocate(geonc)
1357  deallocate(zjpar)
1358  deallocate(fcirc)
1359  deallocate(b02av)
1360  deallocate(b0max)
1361  deallocate(rav)
1362 
1363 !-- write eqdsk file
1364  if ((trim(output) == 'equilibrium' .or. trim(output) == 'full') &
1365  .and. eqdsk_file) then
1366  call write_eqdsk(a, ip, rvac, bvac, qprof, path)
1367  end if
1368 
1369 !TODO
1370 ! deallocate(dp)
1371 ! deallocate(fdf)
1372 ! deallocate(j_tor)
1373 ! deallocate(q_in)
1374 
1375  deallocate(qprof)
1376 
1377  deallocate(psivec)
1378  deallocate(dpres, p_int, dgam, gam_int)
1379 
1380  call deallocate_spline_coefficients(gam_spline)
1381  call deallocate_spline_coefficients(dp_spline)
1382  call deallocate_spline_coefficients(j_spline)
1383 
1384  deallocate(psi, xx, yy)
1385  deallocate(nodeno)
1386 
1387  call equilibrium_destructor(equilibrium)
1388  if (allocated(dp)) deallocate(dp)
1389  if (allocated(fdf)) deallocate(fdf)
1390  if (allocated(j_tor)) deallocate(j_tor)
1391  if (allocated(q_in)) deallocate(q_in)
1392  if (allocated(psi_in)) deallocate(psi_in)
1393  deallocate(s_acc, sig, weights)
1394 
1395 !-- format statements
1396  2 format('a : ', e12.4)
1397  3 format('b : ', e14.6)
1398  4 format('alfa : ', e14.6)
1399  5 format('radius : ', e14.6)
1400  6 format('b0 : ', e14.6)
1401  7 format('cpsurf : ', e14.6)
1402  13 format('magnetic axis : x = ', e14.6, ' y = ', e14.6)
1403 
1404  write(*, *) 'helena end'
1405  !call system('date +%s%N')
1406 
1407  if (standard_output) close(out_he)
1408 
1409  return
1410 
1411 end subroutine helena
1412 
1413 !***********************************************************************
1414 
subroutine suydam_ballooning(equilibrium_out, zvol, zvolp, xaxis)
subroutine write_eqdsk(a, curr, r0, b0, qprof, path)
Definition: write_eqdsk.f90:1
subroutine helena_initialization
subroutine helena(equilibrium_in, equilibrium_out, in_path, code_parameters)
Definition: helena.f90:1
subroutine mapping(cx, cy, xaxis, yaxis, a, equilibrium_out)
Definition: mapping_mod.f90:16
subroutine, public equilibrium_constructor(equilibrium, nr, nchi)
subroutine plot_data_2d(type_plot, x, y, printname, z)
Definition: plot_data.f90:109
Definition: solver.f90:1
subroutine si_output(a, r0, b0, fcirc, qprof, dqprof, rav, geonc, zjpar, dimerc, drmerc, hh, current)
Definition: si_output.f90:1
real(r8) function, dimension(n), public integrate(f_spline, x, n, inv)
subroutine, public equidistant_profile(f, x, f_equi, x_equi)
subroutine helena_assign_code_parameters(code_parameters, return_status)
subroutine output(NGRID, betpol, zli3)
Definition: Eq2_m.f:1
subroutine allocate_spline_coefficients(spline, n)
subroutine flxint(xaxis, a, nmg, fscale)
Definition: flxint.f90:1
subroutine passing_particles(a, fcirc, b02av, b0max, rav, equilibrium)
subroutine, public fill_equilibrium(a, xaxis, yaxis, current_averaging, equilibrium)
subroutine remesh(a, nrnew, npnew, meshno, cx, cy, xaxis, yaxis, nax, rax, sax)
Definition: remesh.f90:1
subroutine spline(N, X, Y, ALFA, BETA, TYP, A, B, C, D)
Definition: solution6.f90:655
subroutine deallocate_solver
Definition: solver.f90:42
REAL *8 function spwert(N, XWERT, A, B, C, D, X, ABLTG)
Definition: solution6.f90:155
subroutine rft2(data, nr, kr)
Definition: rft2.f90:1
subroutine plot_data_1d(type_plot, x, y, np, printname, z)
Definition: plot_data.f90:11
subroutine write_equidistant_profiles(equilibrium, pskn1, nr)
Definition: mod_output.f90:16
subroutine mercier(a, dimerc, drmerc, hh, qq, dq, geonc, zjpar)
Definition: mercier.f90:1
subroutine gaussian_points
subroutine, public si_currents
subroutine current(GEOMETRY, PROFILES, TRANSPORT, SOURCES, EVOLUTION, CONTROL, j_boun, ifail, failstring)
CURRENT TRANSPORT EQUATION.
subroutine initial_grid(fr)
Definition: initial_grid.f90:1
real(r8) function, public plasma_volume(equilibrium, rminor, eps)
subroutine deallocate_spline_coefficients(spline)
subroutine flxint2(xaxis, a, cx, cy, sumdq)
Definition: flxint2.f90:1
subroutine, public total_current(a, xaxis, toroidal_current)
real(r8) function, public w_mhd(equilibrium, rminor, eps)
subroutine, public equilibrium_destructor(equilibrium)
Definition: mod_itm.f90:7
subroutine transfer_1d_profile(x_in, f_in, x_out, f_out, df_out, spline_type, monotonic)
subroutine, public current_calculations_destructor
subroutine node_numbers
Definition: node_numbers.f90:1
subroutine set_node_number(n_node, n1, n2, n3, n4)
subroutine fourier_backtransform(fm, mfm)
real(r8) function integrate_1d(f, x, x_low, x_high, sum)
subroutine allocate_solver(nr, np)
Definition: solver.f90:18
subroutine p_j_iteration(equil_in, equil_out, first, a, cx, cy, psaxis, xaxis, yaxis, nax, rax, sax)
subroutine write_parameters
subroutine current_at_nodes(a, equilibrium)
subroutine safety_factor(xaxis, a, cx, cy, qprf, q95out, q1out)
real(r8) function pressure(flux)
subroutine, public current_calculations_constructor(nr, np)
subroutine shape_from_points(R_bnd, Z_bnd, n_bnd, mfm, Rgeo, amin, fr)
subroutine diagnostics(a, xaxis, yaxis, zvol, zvolp, current)
Definition: diagnostics.f90:1