12 real(r8),
allocatable,
private :: cchi(:, :)
16 subroutine mapping(cx, cy, xaxis, yaxis, a, equilibrium_out)
45 integer(itm_i4),
parameter :: out_dat = 16, out_vec = 21
47 real(r8),
intent(in) :: cx, cy, xaxis, yaxis, a
49 type(type_equilibrium
) :: equilibrium_out
52 character(len = 132) :: grid_type(4)
55 real(r8),
dimension(nr) :: pskn1, work1
56 real(r8),
dimension(nr) :: p0tmp, ftmp, dptmp, dftmp
57 real(r8),
dimension(nr) :: ppelite, felite, ffpelite, pppelite, fppelite
59 real(r8),
dimension(nr) :: nne, dnne, tte, dtte
60 real(r8),
dimension(2 * nr - 1) :: cuplot, xplot,
pplot, &
61 psiplot, qplot, dqplot
62 real(r8),
dimension((nr - 1) * nchi) :: xchi, ychi
65 integer(itm_i4) :: i, j, k
66 integer(itm_i4) :: n1, n2, n3, n4, no
67 integer(itm_i4) :: nom, nop
68 integer(itm_i4) :: ierr, jerr
69 integer(itm_i4) :: jbase
70 integer(itm_i4) :: ifail
71 integer(itm_i4) :: nedgelab
72 integer(itm_i4) :: ileft, iright
74 real(r8) :: maxerr, errj, serr, cerr
76 real(r8) :: pax, paxis, bm, b0, r0
77 real(r8) :: rbscale, pscale0, rbscale0
78 real(r8) :: rminor, rmag, raxis
79 real(r8) :: sumq, sumqr, zsumq, zsumqr
80 real(r8) :: zpsi, dzpsi, ddzpsi, zchi
81 real(r8) :: psir, psirr
83 real(r8) :: x, xr, xs, xrs, xrr, xss
84 real(r8) :: y, yr, ys, yrs, yrr, yss
85 real(r8) :: dchi, chir, chis, chirs, chirr, chiss
86 real(r8) :: jacobian, jacobian2
88 real(r8) :: dum, dum1, dum2, dum3, dum4, dummy
91 real(r8) :: qq, dqq, rb, drb
92 real(r8) :: psix, psiy, chix, chiy
93 real(r8) :: grps2, grpgrc, grchi2
94 real(r8) :: a0, a1, a2, a3
95 real(r8) :: omega, rold, zold, bpold, r, z, leng, bp
97 real(r8) :: qcalc, qnorm
98 real(r8) :: dndpsico, dtdpsico
99 real(r8) :: defte, tefte
100 real(r8) :: conste, consde
102 real(r8) :: psr, pss, psrs, psrr, psss
103 real(r8) :: grad_psi2
104 real(r8) :: xleft, xright
107 real(r8),
dimension(nr, nchi) :: xout, yout
108 real(r8),
dimension(nr, nchi) :: cr, cz
109 real(r8),
dimension(nr, nchi) :: br, bz, bphi
110 real(r8),
dimension(nchi) :: vx, vy
111 real(r8),
dimension(nr) :: psi_out, p_out, rbphi_out, dp_out
112 real(r8),
dimension(nr, 1) :: psi_out_2d
113 real(r8) :: cpsurf_out
115 real(r8) :: r_geo_flux_surface, a_flux_surface
116 real(r8) :: r_min_flux_surface, r_max_flux_surface
117 real(r8) :: delta_upper, delta_lower
120 real(r8),
dimension(nr) :: c1
127 real(r8),
dimension(nr) :: drbphi_out, rho, r_in
128 real(r8),
dimension(nr) :: r_geo, rho_vol, dq_dpsi, dv_dpsi, i_tor
129 real(r8),
dimension(nr) :: stability_alpha, global_shear
130 integer(itm_i4),
parameter :: n_string = 39, len_string = 16
131 character,
dimension(n_string) :: string*(len_string) = &
132 (/
' psi_bar ',
' radius s ',
' psi ', &
133 ' psi_tilde ',
' r_inboard ',
' R_inboard ', &
134 ' r_outboard ',
' R_outboard ',
' Rgeo ', &
135 ' rho_vol ',
' rho_vol_bar ',
' rho_vol_tilde ', &
136 ' phi ',
' rho_tor ', &
137 ' area ',
' volume ',
' dV/dpsi ', &
138 ' p ',
' dp/dpsi ',
' dp/dpsi_tilde ', &
139 ' F ',
' dF/dpsi ',
' dF/dpsi_tilde ', &
140 ' FdF/dpsi_tilde',
' q ',
' dq/dpsi ', &
141 ' <j_tor> ',
' I_tor ',
' alpha ', &
142 ' global shear ',
' gm1 ',
' gm2 ', &
143 ' gm3 ',
' gm4 ',
' gm5 ', &
144 ' gm6 ',
' gm7 ',
' gm8 ', &
146 character :: header_string*(len_string * n_string)
150 grid_type(2) =
'inverse'
152 grid_type(4) =
'straight field line'
170 if (ias == 1) factas =1._r8
174 call
profiles(p0, rbphi, dp0, drbphi, a)
177 pskn1(i) = psikn(nr + 1 - i)
180 if (standard_output)
then
182 write(out_he, *)
'*************************************'
183 write(out_he, *)
'* pressure profile before norm. : *'
184 write(out_he, *)
'*************************************'
185 write(out_he, 91) (p0(i) * eps / alfa**2, i = 1, nr)
186 write(out_he, *)
'*************************************'
189 write(out_he, *)
'*************************************'
190 write(out_he, *)
'* denormalized pressure profile : *'
191 write(out_he, *)
'*************************************'
192 write(out_he, 91) (p0(i) * eps * bvac**2 / (alfa**2 * 4 * pi &
193 * 1e-07_r8), i = 1, nr)
194 write(out_he, *)
'*************************************'
198 pax = p0(1) * eps / (alfa * alfa)
200 raxis = 1._r8 + eps * xaxis
201 bm = rbphi(1) / raxis
203 if (verbosity > 2)
then
204 write(iu6, *)
'********magnetic/vacuum axis****************************'
205 write(iu6, *)
'vacuum magnetic axis rvac =', rvac,
' m'
206 write(iu6, *)
'plasma magnetic axis rmag =', raxis * rvac,
' m'
207 write(iu6, *)
'shift rmag/rvac =', raxis
208 write(iu6, *)
'vacuum magnetic field on axis bvac =', bvac,
'T'
209 write(iu6, *)
'plasma magnetic field on axis bmag =', bm * bvac,
'T'
210 write(iu6, *)
'bmag/bvac =', bm
211 write(iu6, *)
'********************************************************'
217 pscale = b0**2 * eps / alfa**2
220 p0(i) = p0(i) * pscale
221 dp0(i) = dp0(i) * pscale
222 rbphi(i) = rbphi(i) * rbscale
223 drbphi(i) = drbphi(i) * rbscale
225 cpsurf = radius**2 * b0 / alfa
226 cpsurf_out = twopi * eps**2 * rvac**2 * bvac / alfa
228 if (verbosity > 2)
then
229 write(iu6, *)
'++++++++++++++++++++++++++++++++++++++++++++++++++++++++'
230 write(iu6, *)
'consistency check for total poloidal ', &
231 'at the plasma boundary (cpsurf_out):'
232 write(iu6, *)
'poloidal flux normalized to 2*Pi*bmag*rmag**2 ', &
233 'psi_1_hat = ', cpsurf
234 write(iu6, *)
'unnormalized poloidal flux psi_1 = ', cpsurf_out
235 write(iu6, *)
'unnormalized poloidal flux on input psi_1 = ', cpsurfin
236 write(iu6,*)
'+++++++++++++++++++++++++++++++++++++++++++++++++++++++++'
242 if (standard_output)
then
243 write(out_he, 2) radius
245 write(out_he, 4) cpsurf
249 if ((trim(
output) ==
'equilibrium' .or. trim(
output) ==
'full') &
251 open (unit = out_vec, file = trim(adjustl(path)) // file_vec, &
252 status =
'replace', form =
'formatted', action =
'write', &
254 write(out_vec, *) nr, nchi, eps
260 allocate(cchi(4, nr * np))
269 psir = -dpsikn(i) / (2._r8 * (nr - 1))
271 psirr = ddpsikn(i) / (2._r8 * (nr - 1))**2
272 cs(nr - i + 1) = sqrt(zpsi)
274 n1 = (i - 1) * np + j
280 call
interpolation(2, xx(1, n1), xx(1, n2), xx(1, n3), xx(1, n4), &
281 -1._r8, s, x, xr, xs, xrs, xrr, xss)
282 call
interpolation(2, yy(1, n1), yy(1, n2), yy(1, n3), yy(1, n4), &
283 -1._r8, s, y, yr, ys, yrs, yrr, yss)
284 call
interpolation(2, psi(4 * (n1 - 1) + 1), psi(4 * (n2 - 1) &
285 + 1), psi(4 * (n3 - 1) + 1), psi(4 * (n4 - 1) + 1), -1._r8, s, &
286 ps, psr, pss, psrs, psrr, psss)
287 jacobian = xr * ys - xs * yr
288 er = xrr * ys + xr * yrs - xrs * yr - xs * yrr
289 bigr = 1._r8 + eps * x
291 dl = sqrt(xs**2 + ys**2)
292 grad_psi2 = psr**2 * (xs**2 + ys**2) / jacobian**2
293 sumq = sumq + wgauss(k) / (bigr * sqrt(grad_psi2)) * dl
295 sumqr = sumqr + psirr * jacobian / ((psir**2) * bigr) * wgauss(k)
296 sumqr = sumqr - er / (bigr * psir) * wgauss(k)
297 sumqr = sumqr + jacobian * eps * xr / ((bigr**2) * psir) * wgauss(k)
299 cchi(1, (i - 1) * np + j + 1) = sumq
300 cchi(2, (i - 1) * np + j + 1) = sumqr
301 call
interpolation(2, xx(1, n1), xx(1, n2), xx(1, n3), xx(1, n4), &
302 -1._r8, 1._r8, x, xr, xs, xrs, xrr, xss)
303 call
interpolation(2, yy(1, n1), yy(1, n2), yy(1, n3), yy(1, n4), &
304 -1._r8, 1._r8, y, yr, ys, yrs, yrr, yss)
305 jacobian = xr * ys - xs * yr
306 er = xrr * ys + xr * yrs - xrs * yr - xs * yrr
307 bigr = 1._r8 + eps * x
308 zsumq = -jacobian / (bigr * abs(psir))
309 zsumqr = psirr * jacobian / (psir**2 * bigr)
310 zsumqr = zsumqr - er / (bigr * psir)
311 zsumqr = zsumqr + jacobian * eps * xr / (bigr**2 * psir)
312 cchi(3, (i - 1) * np + j + 1) = zsumq
313 cchi(4, (i - 1) * np + j + 1) = zsumqr
315 cchi(1, (i - 1) * np + 1) = 0._r8
316 cchi(2, (i - 1) * np + 1) = 0._r8
317 n1 = (i - 1) * np + 1
321 call
interpolation(2, xx(1, n1), xx(1, n2), xx(1, n3), xx(1, n4), &
322 -1._r8, -1._r8, x, xr, xs, xrs, xrr, xss)
323 call
interpolation(2, yy(1, n1), yy(1, n2), yy(1, n3), yy(1, n4), &
324 -1._r8, -1._r8, y, yr, ys, yrs, yrr, yss)
325 jacobian = xr * ys - xs * yr
326 er = xrr * ys + xr * yrs - xrs * yr - xs * yrr
327 bigr = 1._r8 + eps * x
328 zsumq = -jacobian / (bigr * abs(psir))
329 zsumqr = psirr * jacobian / (psir**2 * bigr)
330 zsumqr = zsumqr - er / (bigr * psir)
331 zsumqr = zsumqr + jacobian * eps * xr / (bigr**2 * psir)
332 cchi(3, (i - 1) * np + 1) = zsumq
333 cchi(4, (i - 1) * np + 1) = zsumqr
334 qs(nr - i + 1) = 0.5_r8 * factas * sumq * rbphi(nr - i + 1) / rbscale
335 dqs(nr - i + 1) = sumqr * rbphi(nr - i + 1) + sumq &
336 * drbphi(nr - i + 1) / (2._r8 * (nr - 1))
337 dqs(nr - i + 1)= 0.5_r8 * factas * dqs(nr - i + 1) / rbscale
339 if (eps <= 0.01_r8 .and. p0(1) <= 0._r8)
then
340 s2 = sqrt(psikn(nr - 1))
341 s3 = sqrt(psikn(nr - 2))
342 qs(1) = qs(2) - (qs(3) - qs(2)) / (s3 - s2) * s2
346 qs(1) = pi / (2._r8 * sqrt(cx * cy) * (1. + eps * xaxis))
351 dum = cchi(1, i * np)
352 no = (i - 1) * np + j
353 cchi(1, no) = (1._r8 + ias) * pi * cchi(1, no) / dum
354 dum2 = cchi(2, i * np)
355 cchi(2, no) = (1._r8 + ias) * pi * cchi(2, no) / dum
356 cchi(3, no) = (1._r8 + ias) * pi * cchi(3, no) / dum
357 cchi(4, no) = (1._r8 + ias) * pi * cchi(4, no) / dum
360 dqq = dqs(nr - i + 1)
361 rb = rbphi(nr - i + 1)
362 drb = drbphi(nr - i + 1) / (2 * (nr - 1))
363 cchi(2, no)= (dqq / qq - drb / rb) * cchi(1, no) - cchi(2, no)
364 cchi(4, no)= (dqq / qq - drb / rb) * cchi(3, no) - cchi(4, no)
368 qs(i) = qs(i) * alfa / pi
369 qplot(nr + 1 - i) = qs(i)
370 dqs(i) = dqs(i) * alfa / pi
371 dqplot(nr + 1 - i) = dqs(i)
375 if (standard_output)
then
377 write(out_he, 31) qs(1)
378 write(out_he, 32) qs(nr)
385 chikn(j) = pi * (j - 1) / dble(nchi - 1)
386 chi(j) = pi * (j - 1) / dble(nchi - 1)
390 chikn(j) = 2._r8 * pi * (j - 1) / dble(nchi)
391 chi(j) = 2._r8 * pi * (j - 1) / dble(nchi)
396 psir = -dpsikn(i) / (2._r8 * dble(nr - 1))
398 no = (i - 1) * nchi + 1
401 n1 = (i - 1) * np + k
405 call
interpolation(2, xx(1, n1), xx(1, n2), xx(1, n3), xx(1, n4), &
406 -1._r8, s, xchi(no), xr, xs, xrs, xrr, xss)
407 call
interpolation(2, yy(1, n1), yy(1, n2), yy(1, n3), yy(1, n4), &
408 -1._r8, s, ychi(no), yr, ys, yrs, yrr, yss)
409 call
interpolation(2, cchi(1, n1), cchi(1, n2), cchi(1, n3), &
410 cchi(1, n4), -1._r8, s, dchi, chir, chis, chirs, chirr, chiss)
417 jacobian = xr * ys - xs * yr
418 jacobian2 = jacobian**2
420 psix = psir * ys / jacobian
421 psiy = -psir * xs / jacobian
422 chix = (chir * ys - chis * yr) / jacobian
423 chiy = (-chir * xs + chis * xr)/ jacobian
424 if (vec_file)
write(out_vec, 61) sqrt(zpsi), dchi, xchi(no), &
425 ychi(no), psix, psiy, chix, chiy
427 grps2 = psir**2 * (xs**2 + ys**2) / jacobian2
432 g11_hel(nr - i + 1, 1) = grps2 * (cpsurf / radius)**2
433 grpgrc = (chir * psir * (xs**2 + ys**2) - chis * psir * (xr * xs &
434 + yr * ys)) / jacobian2
435 g12_hel(nr - i + 1, 1) = grpgrc * cpsurf / radius**2
436 g33_hel(nr - i + 1, 1) = ((1._r8 + eps * xaxis) / (1._r8 + eps &
442 xout(nr - i + 1, 1) = xchi(no)
443 yout(nr - i + 1, 1) = ychi(no)
444 cr(nr - i + 1, 1) = xchi(no)
445 cz(nr - i + 1, 1) = ychi(no)
449 br(nr - i + 1, 1) = -psiy / (eps * (1._r8 + eps * xchi(no))) &
451 bz(nr - i + 1, 1) = psix / (eps * (1._r8 + eps * xchi(no))) &
453 bphi(nr - i + 1, 1) = rbphi(nr - i + 1) / (1._r8 + eps * xchi(no))
455 grchi2 = chix**2 + chiy**2
456 dum1 = rbphi(nr - i + 1)**2 / (qs(nr - i + 1)**2 &
457 / g33_hel(nr - i + 1, 1))
458 dum2 = g11_hel(nr - i + 1, 1) * grchi2 / radius**2
459 dum3 = g12_hel(nr - i + 1, 1)
460 dum4 = dum2 - dum3 * dum3
461 errj = abs(dum4 - dum1)
462 if (errj > maxerr)
then
475 no = (i - 1) * nchi + j
476 if ((cchi(1, (i - 1) * np + k) <= zchi .and. cchi(1, &
477 (i - 1) * np + k + 1) >= zchi) .or. (j == nchi &
478 .and. k == np - 1 .and. ias == 0))
then
480 nom = (i - 1) * np + k
482 a3 = (cchi(1, nom) + cchi(3, nom) - cchi(1, nop) &
483 + cchi(3, nop)) / 4._r8
484 a2 = (-cchi(3, nom) + cchi(3, nop)) / 4._r8
485 a1 = (-3 * cchi(1, nom) - cchi(3, nom) + 3 * cchi(1, nop) &
486 - cchi(3, nop)) / 4._r8
487 a0 = (2 * cchi(1, nom) + cchi(3, nom) + 2 * cchi(1, nop) &
488 - cchi(3, nop)) / 4._r8 - zchi
490 if (ias == 0 .and. j == nchi)
then
495 n1 = (i - 1) * np + k
500 xx(1, n4), -1._r8, s, xchi(no), xr, xs, xrs, xrr, xss)
502 yy(1, n4), -1._r8, s, ychi(no), yr, ys, yrs, yrr, yss)
503 call
interpolation(2, cchi(1, n1), cchi(1, n2), cchi(1, n3), &
504 cchi(1, n4), -1._r8, s, dchi, chir, chis, chirs, chirr, &
512 jacobian = xr * ys - xs * yr
513 jacobian2 = jacobian**2
515 psix = psir * ys / jacobian
516 psiy = -psir * xs / jacobian
517 chix = (chir * ys - chis * yr) / jacobian
518 chiy = (-chir * xs + chis * xr) / jacobian
519 if (vec_file)
write(out_vec, 61) sqrt(zpsi), dchi, xchi(no), &
520 ychi(no), psix, psiy, chix, chiy
522 grps2 = psir**2 * (xs**2 + ys**2) / jacobian2
523 g11_hel(nr - i + 1, j) = grps2 * (cpsurf / radius)**2
524 grpgrc = (chir * psir * (xs**2 + ys**2) - chis * psir &
525 * (xr * xs + yr * ys)) / jacobian2
526 g12_hel(nr - i + 1, j) = grpgrc * cpsurf / radius**2
527 g33_hel(nr - i + 1, j) = ((1._r8 + eps * xaxis) &
528 / (1._r8 + eps * xchi(no)))**2
529 xout(nr - i + 1, j) = xchi(no)
530 yout(nr - i + 1, j) = ychi(no)
531 cr(nr - i + 1, j) = xchi(no)
532 cz(nr - i + 1, j) = ychi(no)
536 br(nr - i + 1, j) = -psiy / (eps * (1._r8 + eps * xchi(no))) &
538 bz(nr - i + 1, j) = psix / (eps * (1._r8 + eps * xchi(no))) &
540 bphi(nr - i + 1, j) = rbphi(nr - i + 1) / (1._r8 + eps &
543 grchi2 = chix**2 + chiy**2
544 dum1 = rbphi(nr - i + 1)**2 / (qs(nr - i + 1)**2 &
545 / g33_hel(nr - i + 1, j))
546 dum2 = g11_hel(nr - i + 1, j) * grchi2 / radius**2
547 dum3 = g12_hel(nr - i + 1, j)
548 dum4 = dum2 - dum3 * dum3
549 errj = abs(dum4 - dum1)
550 if (errj > maxerr)
then
559 if (standard_output) &
560 write(out_he, *)
'error in solve_cubic i,j,k : ', i, j, k, &
562 if (verbosity > 3)
then
563 write(iu6, *) a0, a1, a2, a3, zchi
564 write(iu6, *) cchi(1, (i - 1) * np + k), cchi(1, (i - 1) &
576 if (standard_output)
then
578 write(out_he, *)
'***************************************************'
579 write(out_he, 62) maxerr, serr, cerr, ierr, jerr
580 write(out_he, *)
'***************************************************'
583 if (verbosity > 2)
then
584 write(iu6, *)
'a = ', a
585 write(iu6, *)
'b = ', b
586 write(iu6, *)
'alfa = ', alfa
591 write(out_vec, 11) (p0(i), rbphi(i), qs(i), i = 1, nr)
592 write(out_vec, 11) cpsurf
601 rmag = rminor / radius
603 psi_out(i) = cpsurf_out * psikn(nr + 1 - i)
604 p_out(i) = p0(i) * bmag**2 / mu0
605 rbphi_out(i) = rbphi(i) * rmag * bmag
612 g11_hel(1, : ) = 0._r8
613 g33_hel(1, : ) = 1._r8
617 c1(1 : nr - 1) = g12_hel(2 : nr, j)
618 call
spline(nr - 1, cs(2 : nr), c1, 0._r8, 0._r8, 3, coeff)
619 g12_hel(1, j) =
spwert(nr - 1, 0._r8, coeff, cs(2 : nr), abltg, 0)
625 bphi(1, : ) = rvac / rmag
628 g11_hel = g11_hel * (twopi * rmag * bmag)**2
629 g12_hel = g12_hel * twopi * bmag
630 g33_hel = g33_hel / rmag**2
632 cr = rvac + rminor * cr
633 cz = zgeo + rminor * cz
635 br = br * bmag * rmag**2 / rvac**2
636 bz = bz * bmag * rmag**2 / rvac**2
637 bphi = bphi * bmag * rmag / rvac
642 dp_out(i) = -0.5_r8 * a * b *
dp_dpsi(psikn(nr - i + 1))
644 dp_out(i) = -eps * a * b *
dp_dpsi(psikn(nr - i + 1))
648 dp_out = dp_out * eps * cpsurf_out / (mu0 * rminor**4 * twopi**2)
650 vx = rvac + rminor * vx
651 vy = zgeo + rminor * vy
652 xout(1, :) = rvac + rminor * xaxis
653 yout(1, :) = zgeo + rminor * yaxis
654 xout(2 : nr, :) = rvac + rminor * xout(2 : nr, :)
655 yout(2 : nr, :) = zgeo + rminor * yout(2 : nr, :)
659 call
spline(nr, psi_out, qs, 0._r8, 0._r8, 3, coeff)
660 equilibrium_out%profiles_1d%phi =
integrate(coeff, psi_out, nr, .false.)
667 equilibrium_out%profiles_1d%rho_tor &
668 = sqrt(equilibrium_out%profiles_1d%phi / pi &
669 / equilibrium_out%global_param%toroid_field%b0)
673 call
spline(nr, equilibrium_out%profiles_1d%psi, &
674 equilibrium_out%profiles_1d%volume, 0._r8, 0._r8, 3, coeff)
676 dummy =
spwert(nr, equilibrium_out%profiles_1d%psi(i), coeff, &
677 equilibrium_out%profiles_1d%psi, abltg, 1)
678 equilibrium_out%profiles_1d%vprime(i) = abltg(1)
680 call
spline(nr, equilibrium_out%profiles_1d%psi, &
681 equilibrium_out%profiles_1d%area, 0._r8, 0._r8, 3, coeff)
683 dummy =
spwert(nr, equilibrium_out%profiles_1d%psi(i), coeff, &
684 equilibrium_out%profiles_1d%psi, abltg, 1)
685 equilibrium_out%profiles_1d%aprime(i) = abltg(1)
687 call
spline(nr, equilibrium_out%profiles_1d%rho_tor, &
688 equilibrium_out%profiles_1d%psi, 0._r8, 0._r8, 3, coeff)
690 dummy =
spwert(nr, equilibrium_out%profiles_1d%rho_tor(i), coeff, &
691 equilibrium_out%profiles_1d%rho_tor, abltg, 1)
692 equilibrium_out%profiles_1d%dpsidrho_tor(i) = abltg(1)
697 equilibrium_out%profiles_1d%psi = psi_axis &
698 + equilibrium_out%profiles_1d%psi - equilibrium_out%profiles_1d%psi(1)
701 equilibrium_out%global_param%psi_bound = &
702 equilibrium_out%profiles_1d%psi(nr)
703 equilibrium_out%global_param%psi_ax = &
704 equilibrium_out%profiles_1d%psi(1)
707 equilibrium_out%profiles_1d%q = qs
710 equilibrium_out%global_param%mag_axis%q = equilibrium_out%profiles_1d%q(1)
711 equilibrium_out%global_param%q_min = minval(abs(equilibrium_out%profiles_1d%q)) &
712 * sign(1.0_r8, equilibrium_out%profiles_1d%q(1))
716 call
spline(nr, (equilibrium_out%profiles_1d%psi - equilibrium_out%profiles_1d%psi(1)) &
717 / (equilibrium_out%profiles_1d%psi(nr) - equilibrium_out%profiles_1d%psi(1)), &
718 equilibrium_out%profiles_1d%q, 0._r8, 0._r8, 2, coeff)
720 equilibrium_out%global_param%q_95 =
spwert(nr, 0.95_r8, coeff, &
721 (equilibrium_out%profiles_1d%psi - equilibrium_out%profiles_1d%psi(1)) &
722 / (equilibrium_out%profiles_1d%psi(nr) - equilibrium_out%profiles_1d%psi(1)), abltg, 0)
728 equilibrium_out%profiles_2d(1)%grid%dim1 = equilibrium_out%profiles_1d%psi
730 equilibrium_out%profiles_2d(1)%grid%dim2(j) = (j - 1) * twopi &
732 equilibrium_out%profiles_2d(1)%theta( : , j) = equilibrium_out%profiles_2d(1)%grid%dim2(j)
733 equilibrium_out%profiles_2d(1)%psi( : , j) = equilibrium_out%profiles_1d%psi
735 equilibrium_out%profiles_2d(1)%br = br
736 equilibrium_out%profiles_2d(1)%bz = bz
737 equilibrium_out%profiles_2d(1)%bphi = bphi
740 equilibrium_out%eqgeometry%boundary(1)%r = vx
741 equilibrium_out%eqgeometry%boundary(1)%z = vy
742 equilibrium_out%eqgeometry%boundarytype = 1
745 equilibrium_out%coord_sys%grid_type = grid_type
746 equilibrium_out%coord_sys%grid%dim1 = equilibrium_out%profiles_1d%psi
748 equilibrium_out%coord_sys%grid%dim2(j) = (j - 1) * twopi &
751 equilibrium_out%coord_sys%position%r = cr
752 equilibrium_out%coord_sys%position%z = cz
753 equilibrium_out%profiles_2d(1)%r = cr
754 equilibrium_out%profiles_2d(1)%z = cz
755 equilibrium_out%profiles_2d(1)%grid_type = grid_type
756 equilibrium_out%coord_sys%jacobian = cr**2 / twopi
758 equilibrium_out%coord_sys%jacobian(i, : ) = &
759 equilibrium_out%profiles_1d%q(i) &
760 / equilibrium_out%profiles_1d%F_dia(i) &
761 * equilibrium_out%coord_sys%jacobian(i, : )
763 equilibrium_out%coord_sys%g_11 = g11_hel
764 equilibrium_out%coord_sys%g_12 = g12_hel
765 equilibrium_out%coord_sys%g_13 = 0._r8
767 equilibrium_out%coord_sys%g_22(1, : ) = itm_r8_invalid
769 equilibrium_out%coord_sys%g_22(i, : ) = (1._r8 &
770 / equilibrium_out%coord_sys%jacobian(i, : )**2 &
771 / g33_hel(i, : ) + g12_hel(i, : )**2) / g11_hel(i, : )
773 equilibrium_out%coord_sys%g_23 = 0._r8
774 equilibrium_out%coord_sys%g_33 = g33_hel
779 f_dia = equilibrium_out%profiles_1d%F_dia(i) &
780 * equilibrium_out%eqgeometry%a_minor &
781 / (equilibrium_out%profiles_1d%psi(nr) - psi_axis)
784 / equilibrium_out%eqgeometry%geom_axis%r**2
787 * (equilibrium_out%eqgeometry%a_minor &
788 * equilibrium_out%eqgeometry%geom_axis%r &
789 / (equilibrium_out%profiles_1d%psi(nr) - psi_axis))**2
791 1._r8, f_dia,
'theta ',
b2) / (equilibrium_out%eqgeometry%a_minor &
792 * equilibrium_out%eqgeometry%geom_axis%r &
793 / (equilibrium_out%profiles_1d%psi(nr) - psi_axis))**2
795 1._r8, f_dia,
'theta ',
r_major) &
796 * equilibrium_out%eqgeometry%geom_axis%r
799 / equilibrium_out%eqgeometry%geom_axis%r
803 / (equilibrium_out%eqgeometry%a_minor &
804 * equilibrium_out%eqgeometry%geom_axis%r &
805 / (equilibrium_out%profiles_1d%psi(nr) - psi_axis))**2 &
806 * (equilibrium_out%profiles_1d%q(i) &
807 / (equilibrium_out%profiles_1d%rho_tor(i) &
808 * equilibrium_out%global_param%toroid_field%b0))**2
811 / (equilibrium_out%eqgeometry%a_minor &
812 / (equilibrium_out%profiles_1d%psi(nr) - psi_axis))**2 &
813 * (equilibrium_out%profiles_1d%q(i) &
814 / (equilibrium_out%profiles_1d%rho_tor(i) &
815 * equilibrium_out%global_param%toroid_field%b0))**2
818 * equilibrium_out%eqgeometry%geom_axis%r**2 &
819 * (equilibrium_out%profiles_1d%q(i) &
820 / (equilibrium_out%profiles_1d%rho_tor(i) &
821 * equilibrium_out%global_param%toroid_field%b0))**2
823 1._r8, f_dia,
'theta ',
gradpsi) &
824 * (equilibrium_out%profiles_1d%psi(nr) &
825 - psi_axis) / equilibrium_out%eqgeometry%a_minor &
826 * equilibrium_out%profiles_1d%q(i) &
827 / (equilibrium_out%profiles_1d%rho_tor(i) &
828 * equilibrium_out%global_param%toroid_field%b0)
832 1._r8, f_dia,
'theta ',
b_fun) / abs(equilibrium_out%eqgeometry%a_minor &
833 * equilibrium_out%eqgeometry%geom_axis%r &
834 / (equilibrium_out%profiles_1d%psi(nr) - psi_axis))
835 equilibrium_out%profiles_1d%b_min(i) = minval(sqrt(br(i,:)*br(i,:)+bz(i,:)*bz(i,:)+bphi(i,:)*bphi(i,:)))
836 equilibrium_out%profiles_1d%b_max(i) = maxval(sqrt(br(i,:)*br(i,:)+bz(i,:)*bz(i,:)+bphi(i,:)*bphi(i,:)))
840 call
spline(nr - 1, psi_out(2 : nr), &
841 equilibrium_out%profiles_1d%gm2(2 : nr), 0._r8, 0._r8, 2, coeff)
842 equilibrium_out%profiles_1d%gm2(1) =
spwert(nr - 1, 0._r8, coeff, &
843 psi_out(2 : nr), abltg, 0)
844 call
spline(nr - 1, psi_out(2 : nr), &
845 equilibrium_out%profiles_1d%gm3(2 : nr), 0._r8, 0._r8, 2, coeff)
846 equilibrium_out%profiles_1d%gm3(1) =
spwert(nr - 1, 0._r8, coeff, &
847 psi_out(2 : nr), abltg, 0)
848 call
spline(nr - 1, psi_out(2 : nr), &
849 equilibrium_out%profiles_1d%gm6(2 : nr), 0._r8, 0._r8, 2, coeff)
850 equilibrium_out%profiles_1d%gm6(1) =
spwert(nr - 1, 0._r8, coeff, &
851 psi_out(2 : nr), abltg, 0)
852 call
spline(nr - 1, psi_out(2 : nr), &
853 equilibrium_out%profiles_1d%gm7(2 : nr), 0._r8, 0._r8, 2, coeff)
854 equilibrium_out%profiles_1d%gm7(1) =
spwert(nr - 1, 0._r8, coeff, &
855 psi_out(2 : nr), abltg, 0)
860 r_in = xout( : , nchi)
866 equilibrium_out%profiles_1d%elongation(1) = 1._r8
867 equilibrium_out%profiles_1d%tria_upper(1) = 0._r8
868 equilibrium_out%profiles_1d%tria_lower(1) = 0._r8
870 r_min_flux_surface =
r_min(rminor, xaxis, i)
871 r_max_flux_surface =
r_max(rminor, xaxis, i)
872 a_flux_surface = (r_max_flux_surface - r_min_flux_surface) / 2._r8
873 r_geo_flux_surface = (r_max_flux_surface + r_min_flux_surface) / 2._r8
874 equilibrium_out%profiles_1d%elongation(i) = equilibrium_out%profiles_1d%area(i) &
875 / (pi * a_flux_surface**2)
876 top_point =
rz_top(rminor, xaxis, yaxis, i)
877 bottom_point =
rz_bottom(rminor, xaxis, yaxis, i)
878 delta_upper = r_geo_flux_surface - top_point%R
879 delta_lower = r_geo_flux_surface - bottom_point%R
880 equilibrium_out%profiles_1d%tria_upper(i) = delta_upper / a_flux_surface
881 equilibrium_out%profiles_1d%tria_lower(i) = delta_lower / a_flux_surface
883 equilibrium_out%eqgeometry%elongation = equilibrium_out%profiles_1d%elongation(nr)
884 equilibrium_out%eqgeometry%tria_upper = equilibrium_out%profiles_1d%tria_upper(nr)
885 equilibrium_out%eqgeometry%tria_lower = equilibrium_out%profiles_1d%tria_lower(nr)
887 equilibrium_out%profiles_1d%r_inboard = r_in
888 equilibrium_out%profiles_1d%r_outboard = xout( : , 1)
891 if (trim(
output) ==
'equilibrium' .or. trim(
output) ==
'full') &
894 if (xmgrace_output)
then
895 call
plot_data_1d(
'line', equilibrium_out%profiles_1d%psi,&
896 equilibrium_out%profiles_1d%F_dia, nr,
'xmgr_final_F_psi')
897 call
plot_data_1d(
'line', psi_out, p_out, nr,
'xmgr_final_p_psipol')
899 'xmgr_final_dp_dpsi_psipol')
900 work1 = dp0 * bmag**2 / mu0
902 'xmgr_final_dp_drho_psipol')
903 work1 = drbphi * rmag * bmag
905 'xmgr_final_drbphi_drho_psipol')
906 call
plot_data_1d(
'line', psi_out, qs, nr,
'xmgr_q_psipol')
907 call
plot_data_1d(
'line', vx, vy, nchi,
'xmgr_boundary_x_y_real')
908 call
plot_data_2d(
'2d', xout, yout,
'xmgr_final_flux_surfaces_real')
909 call
plot_data_2d(
'2d_t', xout, yout,
'xmgr_final_radial_real')
910 call
plot_data_2d(
'grid', xout, yout,
'xmgr_final_grid_x_y_real')
911 call
plot_data_1d(
'line', psi_out, p0, nr,
'xmgr_p_bar_psipol')
912 call
plot_data_1d(
'line', psi_out, rbphi, nr,
'xmgr_rbphi_bar_psipol')
919 psi_out_2d(:, 1) = psi_out(:)
920 call
plot_data_2d(
'line', psi_out_2d, g11_hel,
'xmgr_g11_spol')
921 call
plot_data_2d(
'line', psi_out_2d, g12_hel,
'xmgr_g12_spol')
922 call
plot_data_2d(
'line', psi_out_2d, g33_hel,
'xmgr_g33_spol')
925 if (profiles_output)
then
927 open (unit = out_dat, file = trim(adjustl(path)) // file_dat, &
928 status =
'replace', form =
'formatted', action =
'write', &
931 header_string((i - 1) * len_string + 1 : i * len_string) = &
932 string(i)(1 : len_string)
934 write(out_dat,
'(416a)') header_string
936 rho(1) = sqrt(psikn(nr))
939 rho(i) = sqrt(psikn(nr + 1 - i))
940 drbphi_out(i) = drbphi(i) * rmag * bmag / (2._r8 * rho(i)) &
945 call
spline(nr - 1, psi_out(2 : nr), drbphi_out(2 : nr), 0._r8, &
947 drbphi_out(1) =
spwert(nr - 1, 0._r8, coeff, psi_out(2 : nr), abltg, 0)
950 r_geo = 0.5_r8 * (r_in + xout( : , 1))
951 rho_vol = sqrt(equilibrium_out%profiles_1d%volume / (2._r8 * pi**2 &
955 i_tor(1) = equilibrium_out%profiles_1d%jphi(1) &
956 * equilibrium_out%profiles_1d%area(1)
958 i_tor(i) = i_tor(i - 1) + (equilibrium_out%profiles_1d%area(i) &
959 - equilibrium_out%profiles_1d%area(i - 1)) &
960 * equilibrium_out%profiles_1d%jphi(i)
964 call
spline(nr, psi_out, qs, 0._r8, 0._r8, 2, coeff)
966 psi_dummy =
spwert(nr, psi_out(i), coeff, psi_out, abltg, 1)
967 dq_dpsi(i) = twopi * abltg(1)
969 call
spline(nr, psi_out, equilibrium_out%profiles_1d%volume, &
970 0._r8, 0._r8, 2, coeff)
972 psi_dummy =
spwert(nr, psi_out(i), coeff, psi_out, abltg, 1)
973 dv_dpsi(i) = twopi * abltg(1)
978 stability_alpha = -dv_dpsi / pi * rho_vol * mu0 * dp_out
979 global_shear = 2._r8 * equilibrium_out%profiles_1d%volume &
983 psi_bar = psikn(nr + 1 - i)
984 write(out_dat, 16) psi_bar, rho(i), psi_out(i) / twopi, psi_out(i),&
985 rmag - r_in(i), r_in(i), xout(i, 1) - rmag, xout(i, 1), r_geo(i), &
986 rho_vol(i), equilibrium_out%profiles_1d%rho_vol(i), rho_vol(i) &
987 * sqrt(r_geo(i) / r_geo(nr)), equilibrium_out%profiles_1d%phi(i), &
988 equilibrium_out%profiles_1d%rho_tor(i), &
989 equilibrium_out%profiles_1d%area(i), &
990 equilibrium_out%profiles_1d%volume(i), dv_dpsi(i), &
991 p_out(i), twopi * dp_out(i), dp_out(i), rbphi_out(i), twopi &
992 * drbphi_out(i), drbphi_out(i), rbphi_out(i) * drbphi_out(i), &
993 qs(i), dq_dpsi(i), equilibrium_out%profiles_1d%jphi(i), &
994 i_tor(i), stability_alpha(i), global_shear(i), &
995 equilibrium_out%profiles_1d%gm1(i), &
996 equilibrium_out%profiles_1d%gm2(i), &
997 equilibrium_out%profiles_1d%gm3(i), &
998 equilibrium_out%profiles_1d%gm4(i), &
999 equilibrium_out%profiles_1d%gm5(i), &
1000 equilibrium_out%profiles_1d%gm6(i), &
1001 equilibrium_out%profiles_1d%gm7(i), &
1002 equilibrium_out%profiles_1d%gm8(i), &
1003 equilibrium_out%profiles_1d%gm9(i)
1010 if (elite_output)
then
1013 g11_hel = g11_hel / (twopi * rmag * bmag )**2
1014 g12_hel = g12_hel / (twopi * bmag)
1015 g33_hel = g33_hel * rmag**2
1018 call
profiles(p0tmp, ftmp, dptmp, dftmp, a)
1021 cpsurf_out = cpsurf_out / twopi
1022 psi_out = psi_out / twopi
1024 if (verbosity > 3) &
1025 write(iu6, *)
'elite: cpsurf = ', cpsurf,
' , cpsurf_out = ', &
1028 pscale = bvac**2 * eps / alfa**2 / cpsurf_out
1030 rbscale = bvac * rvac
1033 pskn1(i) = psikn(nr + 1 - i)
1037 ppelite(i) = dptmp(i) * pscale / 2._r8 / sqrt(psikn(nr + 1 - i))
1038 felite(i) = ftmp(i) * rbscale
1039 ffpelite(i) = dftmp(i) * ftmp(i) * rbscale**2 / cpsurf_out / 2._r8 &
1040 / sqrt(psikn(nr + 1 - i))
1043 felite(1) = ftmp(1) * rbscale
1044 ppelite(1) = ppelite(2) - (ppelite(2) - ppelite(3)) &
1045 / (psi_out(3) - psi_out(2)) * (psi_out(2) - psi_out(1))
1046 ffpelite(1) = ffpelite(2) - (ffpelite(2) - ffpelite(3)) &
1047 / (psi_out(3) - psi_out(2)) * (psi_out(2) - psi_out(1))
1061 if (xmgrace_output)
then
1063 'xmgr_elite_pprime_realpsipol')
1065 'xmgr_elite_f_realpsipol')
1067 'xmgr_elite_ffprime_realpsipol')
1071 pppelite(i) = ((ppelite(i) - ppelite(i - 1)) / (psi_out(i) &
1072 - psi_out(i - 1)) * (psi_out(i + 1) - psi_out(i)) &
1073 + (ppelite(i + 1) - ppelite(i)) / (psi_out(i + 1) &
1074 - psi_out(i)) * (psi_out(i) - psi_out(i - 1))) &
1075 / (psi_out(i + 1) - psi_out(i - 1))
1076 fppelite(i) = ((ffpelite(i) - ffpelite(i - 1)) / (psi_out(i) &
1077 - psi_out(i - 1)) * (psi_out(i + 1) - psi_out(i)) &
1078 + (ffpelite(i + 1) - ffpelite(i)) / (psi_out(i + 1) &
1079 - psi_out(i)) * (psi_out(i) - psi_out(i - 1))) &
1080 / (psi_out(i + 1) - psi_out(i - 1))
1100 pppelite(1) = pppelite(2) - (pppelite(2) - pppelite(3)) &
1101 / (psi_out(3) - psi_out(2)) * (psi_out(2) - psi_out(1))
1102 fppelite(1) = fppelite(2) - (fppelite(2) - fppelite(3)) &
1103 / (psi_out(3) - psi_out(2)) * (psi_out(2) - psi_out(1))
1104 fppelite(nr) = fppelite(nr - 1) - (fppelite(nr - 1) &
1105 - fppelite(nr - 2)) / (psi_out(nr - 2) - psi_out(nr - 1)) &
1106 * (psi_out(nr - 1) - psi_out(nr))
1107 pppelite(nr) = pppelite(nr - 1) - (pppelite(nr - 1) &
1108 - pppelite(nr - 2)) / (psi_out(nr - 2) - psi_out(nr - 1)) &
1109 * (psi_out(nr - 1) - psi_out(nr))
1113 if (verbosity > 2)
then
1114 write(iu6, *)
'writing elite input'
1115 write(iu6, *)
'alfa =', alfa
1116 write(iu6, *)
'b0, minor radius, rvac, axis =', b0, eps * rvac, &
1117 rvac, raxis / (1 + eps * xaxis)
1118 write(iu6, *)
'rmag =', rmag
1119 write(iu6, *)
'cpsurf_out, psi1 = ', cpsurf_out, (rvac * eps)**2 &
1131 bpold = sqrt(g11_hel(nr, 1)) * cpsurf_out / cpsurf / (vx(1) * rmag)
1135 r = (1._r8 + xx(1, j) * eps) * rvac
1136 z = zgeo + (yy(1, j) * eps) * rvac
1139 dl = sqrt((r - rold)**2 + (z - zold)**2)
1140 bp = sqrt(g11_hel(nr, j)) * cpsurf_out / cpsurf &
1142 omega = omega + 0.5_r8 * dl * (1._r8 / (r**2 * bp) + 1._r8 &
1143 / (rold**2 * bpold))
1149 qcalc = factas * omega * felite(nr) / pi / 2._r8
1150 qnorm = qcalc / qs(nr)
1151 if (verbosity > 2) &
1152 write(iu6, *)
'q_calc = ', omega * felite(nr) / pi / 2._r8, &
1153 'q_helena = ', qs(nr)
1155 open (unit = out_elite, file = trim(adjustl(path)) // file_elite, &
1156 status =
'replace', form =
'formatted', action =
'write', &
1158 open (unit = out_elite_b, file = trim(adjustl(path)) // file_elite_b, &
1159 status =
'replace', form =
'formatted', action =
'write', &
1161 open (unit = out_elite_b9, file = trim(adjustl(path)) // file_elite_b9, &
1162 status =
'replace', form =
'formatted', action =
'write', &
1165 write(out_elite, 1000)
'helena generated input'
1167 write(out_elite, 1001) nr, nchi + 1
1169 write(out_elite, 1001) nr, 2 * nchi - 1
1171 write(out_elite, *)
'psi:'
1172 write(out_elite, 1002) (psi_out(i), i = 1, nr)
1173 write(out_elite, *)
'dp/dpsi:'
1174 write(out_elite, 1002) (ppelite(i), i = 1, nr)
1175 write(out_elite, *)
'd2p/dpsi:'
1176 write(out_elite, 1002) (pppelite(i), i = 1, nr)
1177 write(out_elite, *)
'fpol:'
1178 write(out_elite, 1002) (felite(i), i = 1, nr)
1179 write(out_elite, *)
'ffp:'
1180 write(out_elite, 1002) (ffpelite(i), i = 1, nr)
1181 write(out_elite, *)
'dffp:'
1182 write(out_elite, 1002) (fppelite(i), i = 1, nr)
1183 write(out_elite, *)
'q:'
1184 write(out_elite, 1002) (qs(i), i = 1, nr)
1185 write(out_elite, *)
'r:'
1187 write(out_elite, 1002) (xout(i, j + 1), i = 1, nr)
1190 write(out_elite, 1002) (xout(i, 1), i = 1, nr)
1192 do j = nchi - 2, 0, -1
1193 write(out_elite, 1002) (xout(i, j + 1), i = 1, nr)
1196 write(out_elite, *)
'z:'
1197 if (verbosity > 3) &
1198 write(iu6, *)
'xaxis, yaxis=', xaxis, yaxis
1200 write(out_elite, 1002) (yout(i, j + 1), i = 1, nr)
1203 write(out_elite, 1002) (yout(i, 1), i = 1, nr)
1205 do j = nchi - 2, 0, -1
1206 write(out_elite, 1002) (-yout(i, j + 1), i = 1, nr)
1209 jacobian = xr * ys - xs * yr
1210 write(out_elite, *)
'bp:'
1212 g11_hel(1, j + 1) = 0._r8
1213 write(out_elite, 1002) &
1214 (abs(sqrt(g11_hel(i, j + 1)) * cpsurf_out / cpsurf &
1215 / (cr(i, j + 1) * rmag)), i = 1, nr)
1218 write(out_elite, 1002) &
1219 (abs(sqrt(g11_hel(i, 1)) * cpsurf_out / cpsurf &
1220 / (cr(i, 1) * rmag)), i = 1, nr)
1222 do j = nchi - 2, 0, -1
1223 write(out_elite, 1002) &
1224 (abs(sqrt(g11_hel(i, j + 1)) * cpsurf_out / cpsurf &
1225 / (cr(i, j + 1) * rmag)), i = 1, nr)
1231 if (te%shape == 0)
then
1232 write(out_elite, *)
'ne:'
1233 write(out_elite, 1002) (3.0d19, i = 1, nr)
1234 write(out_elite, *)
'dne/dpsi:'
1235 write(out_elite, 1002) (0.0, i = 1, nr)
1236 write(out_elite, *)
'te:'
1237 write(out_elite, 1002) (1.0, i = 1, nr)
1238 write(out_elite, *)
'dte/dpsi:'
1239 write(out_elite, 1002) (0.0, i = 1, nr)
1240 write(out_elite, *)
'ti:'
1241 write(out_elite, 1002) (1.0, i = 1, nr)
1242 write(out_elite, *)
'dti/dpsi:'
1243 write(out_elite, 1002) (0.0, i = 1, nr)
1250 if (ps >= ne%psi_0)
then
1253 call
ne_te_profile(ne, ps, nne(i), dnne(i), consde, dndpsico)
1257 if (ps >= te%psi_0)
then
1260 call
ne_te_profile(te, ps, tte(i), dtte(i), conste, dtdpsico)
1262 dtte(i) = -dtte(i) * 1000.0_r8
1263 dtte(i) = dtte(i) / cpsurf_out
1264 dnne(i) = dnne(i) / cpsurf_out * 1.e19_r8
1265 nne(i) = nne(i) * 1.e19_r8
1268 write(out_elite, *)
'ne:'
1269 write(out_elite, 1002) (nne(i), i = 1, nr)
1270 write(out_elite, *)
'dne/dpsi:'
1271 write(out_elite, 1002) (dnne(i), i = 1, nr)
1272 write(out_elite, *)
'te:'
1273 write(out_elite, 1002) (tte(i), i = 1, nr)
1274 write(out_elite, *)
'dte/dpsi:'
1275 write(out_elite, 1002) (dtte(i), i = 1, nr)
1277 write(out_elite, *)
'ti:'
1278 write(out_elite, 1002) (tte(i), i = 1, nr)
1279 write(out_elite, *)
'dti/dpsi:'
1280 write(out_elite, 1002) (dtte(i), i = 1, nr)
1284 write(out_elite_b, 1003) &
1285 (xout(nr, j), yout(nr, j), j = 1, nchi)
1287 nedgelab = int(edgelabe * (dble(nr - 1)) / 100._r8)
1288 if (verbosity > 3) &
1289 write(iu6, *)
'writing surface: ', nedgelab
1290 if (nedgelab >= nr)
then
1293 write(out_elite_b9, 1003) &
1294 (xout(nedgelab, j), yout(nedgelab, j), j = 1, nchi)
1304 if (diagnostics_on)
then
1308 ileft = (i - 1) * np + (np + 1) / 2
1310 ileft = (i - 1) * np + np
1312 iright = (i - 1) * np + 1
1313 xleft = xx(1, ileft)
1314 xright = xx(1, iright)
1317 cuplot(i) =
dgamma_dpsi(zpsi) + b * xleft * (1._r8 + eps &
1318 * xleft / 2._r8) *
dp_dpsi(zpsi)
1319 cuplot(2 * nr - i) =
dgamma_dpsi(zpsi) + b * xright * (1._r8 &
1320 + eps * xright / 2._r8) *
dp_dpsi(zpsi)
1322 cuplot(i) =
dgamma_dpsi(zpsi) + b * (1._r8 + eps * xleft)**2 &
1324 cuplot(2 * nr - i) =
dgamma_dpsi(zpsi) + b * (1._r8 + eps &
1327 cuplot(i) = a * cuplot(i) / (1._r8 + eps * xleft)
1329 cuplot(2 * nr - i) = a * cuplot(2 * nr - i) / (1._r8 + eps &
1335 ileft = (i - 1) * np + (np + 1) / 2
1337 ileft = (i - 1) * np + np
1339 iright= (i - 1) * np + 1
1340 xplot(i) = xx(1, ileft)
1341 xplot(2 * nr - i) = xx(1, iright)
1342 pplot(i) = p0(nr - i + 1) / p0(1)
1343 pplot(2 * nr - i) = p0(nr - i + 1) / p0(1)
1344 psiplot(i) = psikn(i)
1345 psiplot(2 * nr - i) = psikn(i)
1346 qplot(2 * nr - i) = qplot(i)
1347 dqplot(2 * nr - i) = dqplot(i)
1349 if (standard_output)
then
1351 write(out_he, *)
'***************************************************'
1352 write(out_he, *)
'* i, x, psi, p, q *'
1353 write(out_he, *)
'***************************************************'
1354 write(out_he, 101) (i, xplot(i), psiplot(i), pax *
pplot(i), &
1355 qplot(i), i = 1, 2 * nr - 1)
1356 write(out_he, *)
'***************************************************'
1358 write(out_he, *)
'***********************************************'
1359 write(out_he, *)
' toroidal current density on the midplane'
1360 write(out_he, *)
'***********************************************'
1361 write(out_he, *)
' x jz '
1362 write(out_he, 77) (xplot(i), cuplot(i), i = 1, 2 * nr - 1)
1366 if (additional_output)
then
1367 write(25, *)
' i, x, psi, p, q '
1368 write(25, 106) (xplot(i), psiplot(i), paxis *
pplot(i), qplot(i), &
1374 2
format(
' radius : ',e12.4)
1375 3
format(
' b0 : ',e12.4)
1376 4
format(
' cpsurf : ',e12.4)
1379 31
format(
' q on axis = ', f7.4)
1380 32
format(
' q at boundary = ', f7.4)
1382 62
format(
' max. error in jacobian after mapping : ', &
1383 es10.3, 2f10.6, 2i4)
1386 101
format(i4,4e12.4)
1390 1002
format(5g20.12)
1391 1003
format(2g20.12)
1403 real(r8),
dimension(nchi) :: x_val, y_val
1404 integer(itm_i4) :: i_start, i_end, i_diff, i_1, i_2, ind(1), j
1405 integer(itm_i4) :: n_spline
1410 i_end = (3 * nchi) / 4
1411 i_diff = i_end - i_start + 1
1416 r_in(1) = xout(1, 1)
1419 y_val(1 : i_diff) = abs(yout(j, i_start : i_end) - zaxis )
1420 ind = minloc(y_val(1 : i_diff)) + i_start - 1
1421 i_1 = ind(1) - n_spline / 2
1422 i_2 = ind(1) + n_spline / 2
1423 x_val(1 : n_spline + 1) = xout(j, i_2 : i_1 : -1)
1424 y_val(1 : n_spline + 1) = yout(j, i_2 : i_1 : -1)
1425 call
spline(n_spline + 1, y_val, x_val, 0._r8, 0._r8, 2, coeff)
1426 r_in(j) =
spwert(n_spline + 1, zaxis, coeff, y_val, abltg, 0)
1436 function r_min(rminor, xaxis, i) result(f_R_min)
1449 integer(itm_i4),
intent(in) :: i
1450 real(r8),
intent(in) :: rminor, xaxis
1454 integer(itm_i4) :: i_tilde
1455 integer(itm_i4) :: n1, n2
1456 integer(itm_i4) :: j, j_min
1457 integer(itm_i4) :: j_next, j_previous
1458 integer(itm_i4) :: ifail
1459 real(r8) :: x_min, s_min
1460 real(r8) :: c1, c2, c3, c4
1461 real(r8) :: aa, bb, cc, det
1462 real(r8),
parameter :: tol = 1.e-8_r8
1467 i_tilde = nr - i + 1
1468 j_min = i_tilde * np
1469 x_min = xx(1, j_min)
1478 i_tilde = nr - i + 1
1481 j_min = (i_tilde - 1) * np + 1
1482 x_min = xx(1, j_min)
1484 do j = (i_tilde - 1) * np + 2, i_tilde * np
1485 if (xx(1, j) < x_min)
then
1491 j_next = mod(j_min, np) + 1 + (i_tilde - 1) * np
1492 j_previous = modulo(j_min - 2, np) + 1 + (i_tilde - 1) * np
1503 aa = 3._r8 * (c1 + c2 - c3 + c4)
1504 bb = 2._r8 * (c4 - c2)
1505 cc = 3._r8 * (c3 - c1) - c2 - c4
1506 det = bb**2 - 4._r8 * aa * cc
1508 if (det > 0._r8)
then
1509 s_min =
root(aa, bb, cc, det, 1._r8)
1510 if (abs(s_min) > 1._r8 + tol)
then
1511 s_min =
root(aa, bb, cc, det, -1._r8)
1512 if (abs(s_min) > 1._r8 + tol)
then
1520 if (ifail == 1)
then
1531 aa = 3._r8 * (c1 + c2 - c3 + c4)
1532 bb = 2._r8 * (c4 - c2)
1533 cc = 3._r8 * (c3 - c1) - c2 - c4
1534 det = bb**2 - 4._r8 * aa * cc
1535 if (det > 0._r8)
then
1536 s_min =
root(aa, bb, cc, det, 1._r8)
1537 if (abs(s_min) > 1._r8 + tol)
then
1538 s_min =
root(aa, bb, cc, det, -1._r8)
1539 if (abs(s_min) > 1._r8 + tol)
then
1548 if (ifail == 1)
then
1549 write(iu6, *)
'Warning: No root found for R_min'
1550 write(iu6, *)
'root replaced by node value'
1555 x_min = 0.25_r8 * (c1 * (s_min - 1)**2 * (s_min + 2) &
1556 + c2 * (s_min - 1)**2 * (s_min + 1) - c3 * (s_min + 1)**2 &
1557 * (s_min - 2) + c4 * (s_min + 1)**2 * (s_min - 1))
1562 f_r_min = rvac + rminor * x_min
1567 function r_max(rminor, xaxis, i) result(f_R_max)
1580 integer(itm_i4),
intent(in) :: i
1581 real(r8),
intent(in) :: rminor, xaxis
1585 integer(itm_i4) :: i_tilde
1586 integer(itm_i4) :: n1, n2
1587 integer(itm_i4) :: j, j_max
1588 integer(itm_i4) :: j_next, j_previous
1589 integer(itm_i4) :: ifail
1590 real(r8) :: x_max, s_max
1591 real(r8) :: c1, c2, c3, c4
1592 real(r8) :: aa, bb, cc, det
1593 real(r8),
parameter :: tol = 1.e-8_r8
1597 i_tilde = nr - i + 1
1598 j_max = (i_tilde - 1) * np + 1
1599 x_max = xx(1, j_max)
1608 i_tilde = nr - i + 1
1611 j_max = (i_tilde - 1) * np + 1
1612 x_max = xx(1, j_max)
1614 do j = (i_tilde - 1) * np + 2, i_tilde * np
1615 if (xx(1, j) > x_max)
then
1621 j_next = mod(j_max, np) + 1 + (i_tilde - 1) * np
1622 j_previous = modulo(j_max - 2, np) + 1 + (i_tilde - 1) * np
1633 aa = 3._r8 * (c1 + c2 - c3 + c4)
1634 bb = 2._r8 * (c4 - c2)
1635 cc = 3._r8 * (c3 - c1) - c2 - c4
1636 det = bb**2 - 4._r8 * aa * cc
1638 if (det > 0._r8)
then
1639 s_max =
root(aa, bb, cc, det, 1._r8)
1640 if (abs(s_max) > 1._r8 + tol)
then
1641 s_max =
root(aa, bb, cc, det, -1._r8)
1642 if (abs(s_max) > 1._r8 + tol)
then
1650 if (ifail == 1)
then
1661 aa = 3._r8 * (c1 + c2 - c3 + c4)
1662 bb = 2._r8 * (c4 - c2)
1663 cc = 3._r8 * (c3 - c1) - c2 - c4
1664 det = bb**2 - 4._r8 * aa * cc
1665 if (det > 0._r8)
then
1666 s_max =
root(aa, bb, cc, det, 1._r8)
1667 if (abs(s_max) > 1._r8 + tol)
then
1668 s_max =
root(aa, bb, cc, det, -1._r8)
1669 if (abs(s_max) > 1._r8 + tol)
then
1678 if (ifail == 1)
then
1679 write(iu6, *)
'Warning: No root found for R_max'
1680 write(iu6, *)
'root replaced by node value'
1685 x_max = 0.25_r8 * (c1 * (s_max - 1)**2 * (s_max + 2) &
1686 + c2 * (s_max - 1)**2 * (s_max + 1) - c3 * (s_max + 1)**2 &
1687 * (s_max - 2) + c4 * (s_max + 1)**2 * (s_max - 1))
1692 f_r_max = rvac + rminor * x_max
1697 function rz_top(rminor, xaxis, yaxis, i) result(f_RZ_top)
1705 use mod_dat, only : rvac, zgeo
1710 integer(itm_i4),
intent(in) :: i
1711 real(r8),
intent(in) :: rminor, xaxis, yaxis
1715 integer(itm_i4) :: i_tilde
1716 integer(itm_i4) :: n1, n2
1717 integer(itm_i4) :: j, j_max
1718 integer(itm_i4) :: j_next, j_previous
1719 integer(itm_i4) :: ifail
1720 real(r8) :: x_max, y_max, s_max
1721 real(r8) :: cx1, cx2, cx3, cx4
1722 real(r8) :: cy1, cy2, cy3, cy4
1723 real(r8) :: aa, bb, cc, det
1724 real(r8),
parameter :: tol = 1.e-8_r8
1732 i_tilde = nr - i + 1
1735 j_max = (i_tilde - 1) * np + 1
1736 y_max = yy(1, j_max)
1738 do j = (i_tilde - 1) * np + 2, i_tilde * np
1739 if (yy(1, j) > y_max)
then
1745 j_next = mod(j_max, np) + 1 + (i_tilde - 1) * np
1746 j_previous = modulo(j_max - 2, np) + 1 + (i_tilde - 1) * np
1761 aa = 3._r8 * (cy1 + cy2 - cy3 + cy4)
1762 bb = 2._r8 * (cy4 - cy2)
1763 cc = 3._r8 * (cy3 - cy1) - cy2 - cy4
1764 det = bb**2 - 4._r8 * aa * cc
1766 if (det > 0._r8)
then
1767 s_max =
root(aa, bb, cc, det, 1._r8)
1768 if (abs(s_max) > 1._r8 + tol)
then
1769 s_max =
root(aa, bb, cc, det, -1._r8)
1770 if (abs(s_max) > 1._r8 + tol)
then
1778 if (ifail == 1)
then
1793 aa = 3._r8 * (cy1 + cy2 - cy3 + cy4)
1794 bb = 2._r8 * (cy4 - cy2)
1795 cc = 3._r8 * (cy3 - cy1) - cy2 - cy4
1796 det = bb**2 - 4._r8 * aa * cc
1797 if (det > 0._r8)
then
1798 s_max =
root(aa, bb, cc, det, 1._r8)
1799 if (abs(s_max) > 1._r8 + tol)
then
1800 s_max =
root(aa, bb, cc, det, -1._r8)
1801 if (abs(s_max) > 1._r8 + tol)
then
1810 if (ifail == 1)
then
1811 write(iu6, *)
'Warning: No root found for RZ_top'
1812 write(iu6, *)
'root replaced by node value'
1817 x_max = 0.25_r8 * (cx1 * (s_max - 1)**2 * (s_max + 2) &
1818 + cx2 * (s_max - 1)**2 * (s_max + 1) - cx3 * (s_max + 1)**2 &
1819 * (s_max - 2) + cx4 * (s_max + 1)**2 * (s_max - 1))
1820 y_max = 0.25_r8 * (cy1 * (s_max - 1)**2 * (s_max + 2) &
1821 + cy2 * (s_max - 1)**2 * (s_max + 1) - cy3 * (s_max + 1)**2 &
1822 * (s_max - 2) + cy4 * (s_max + 1)**2 * (s_max - 1))
1825 f_rz_top%R = rvac + rminor * x_max
1826 f_rz_top%Z = zgeo + rminor * y_max
1831 function rz_bottom(rminor, xaxis, yaxis, i) result(f_RZ_bottom)
1839 use mod_dat, only : rvac, zgeo
1844 integer(itm_i4),
intent(in) :: i
1845 real(r8),
intent(in) :: rminor, xaxis, yaxis
1849 integer(itm_i4) :: i_tilde
1850 integer(itm_i4) :: n1, n2
1851 integer(itm_i4) :: j, j_min
1852 integer(itm_i4) :: j_next, j_previous
1853 integer(itm_i4) :: ifail
1854 real(r8) :: x_min, y_min, s_min
1855 real(r8) :: cx1, cx2, cx3, cx4
1856 real(r8) :: cy1, cy2, cy3, cy4
1857 real(r8) :: aa, bb, cc, det
1858 real(r8),
parameter :: tol = 1.e-8_r8
1863 f_rz_bottom =
rz_top(rminor, xaxis, yaxis, i)
1864 f_rz_bottom%Z = -f_rz_bottom%Z
1874 i_tilde = nr - i + 1
1877 j_min = (i_tilde - 1) * np + 1
1878 y_min = yy(1, j_min)
1880 do j = (i_tilde - 1) * np + 2, i_tilde * np
1881 if (yy(1, j) < y_min)
then
1887 j_next = mod(j_min, np) + 1 + (i_tilde - 1) * np
1888 j_previous = modulo(j_min - 2, np) + 1 + (i_tilde - 1) * np
1903 aa = 3._r8 * (cy1 + cy2 - cy3 + cy4)
1904 bb = 2._r8 * (cy4 - cy2)
1905 cc = 3._r8 * (cy3 - cy1) - cy2 - cy4
1906 det = bb**2 - 4._r8 * aa * cc
1908 if (det > 0._r8)
then
1909 s_min =
root(aa, bb, cc, det, 1._r8)
1910 if (abs(s_min) > 1._r8 + tol)
then
1911 s_min =
root(aa, bb, cc, det, -1._r8)
1912 if (abs(s_min) > 1._r8 + tol)
then
1920 if (ifail == 1)
then
1935 aa = 3._r8 * (cy1 + cy2 - cy3 + cy4)
1936 bb = 2._r8 * (cy4 - cy2)
1937 cc = 3._r8 * (cy3 - cy1) - cy2 - cy4
1938 det = bb**2 - 4._r8 * aa * cc
1939 if (det > 0._r8)
then
1940 s_min =
root(aa, bb, cc, det, 1._r8)
1941 if (abs(s_min) > 1._r8 + tol)
then
1942 s_min =
root(aa, bb, cc, det, -1._r8)
1943 if (abs(s_min) > 1._r8 + tol)
then
1952 if (ifail == 1)
then
1953 write(iu6, *)
'Warning: No root found for RZ_bottom'
1954 write(iu6, *)
'root replaced by node value'
1959 x_min = 0.25_r8 * (cx1 * (s_min - 1)**2 * (s_min + 2) &
1960 + cx2 * (s_min - 1)**2 * (s_min + 1) - cx3 * (s_min + 1)**2 &
1961 * (s_min - 2) + cx4 * (s_min + 1)**2 * (s_min - 1))
1962 y_min = 0.25_r8 * (cy1 * (s_min - 1)**2 * (s_min + 2) &
1963 + cy2 * (s_min - 1)**2 * (s_min + 1) - cy3 * (s_min + 1)**2 &
1964 * (s_min - 2) + cy4 * (s_min + 1)**2 * (s_min - 1))
1967 f_rz_bottom%R = rvac + rminor * x_min
1968 f_rz_bottom%Z = zgeo + rminor * y_min
1997 real(r8),
intent(in) :: a
1998 type(type_equilibrium
) :: equilibrium
2000 real(r8) :: j0, f_dia
2002 real(r8) :: a0, a1, a2, a3
2003 real(r8) :: s, s2, s3
2004 real(r8) :: zpsi, dzpsi, ddzpsi, zchi
2005 integer(itm_i4) :: nelm
2006 integer(itm_i4) :: n1, n2, n3, n4
2007 integer(itm_i4) :: no, nom, nop
2008 integer(itm_i4) :: jbase
2009 integer(itm_i4) :: ifail
2010 integer(itm_i4) :: i, j, k
2014 if (.not.
associated(equilibrium%profiles_1d%psi) &
2015 .or. .not.
associated(equilibrium%profiles_1d%F_dia))
then
2016 write(iu6, *)
'ERROR: psi or F_dia not defined'
2021 j0 = bvac / (mu0 * eps * rvac * alfa)
2027 chikn(j) = pi * (j - 1) / dble(nchi - 1)
2028 chi(j) = pi * (j - 1) / dble(nchi - 1)
2032 chikn(j) = 2._r8 * pi * (j - 1) / dble(nchi)
2033 chi(j) = 2._r8 * pi * (j - 1) / dble(nchi)
2041 no = (i - 1) * nchi + 1
2045 n1 = (i - 1) * np + k
2050 equilibrium%profiles_2d(1)%jphi(nr - i + 1, 1) = - j0 * eps &
2051 *
rh_side(a, xx(1, n1), 0._r8, 0._r8, 0._r8, 0._r8, &
2052 psi(4 * (n1 - 1) + 1), 0._r8, 0._r8)
2053 f_dia = equilibrium%profiles_1d%F_dia(nr - i + 1) &
2054 * equilibrium%eqgeometry%a_minor / equilibrium%profiles_1d%psi(nr)
2055 b_field = sqrt(
b2(a, xx(1, n1), 0._r8, 0._r8, 0._r8, 0._r8, &
2056 psi(4 * (n1 - 1) + 1), 0._r8, f_dia) &
2057 / (equilibrium%eqgeometry%a_minor * equilibrium%eqgeometry%geom_axis%r &
2058 / equilibrium%profiles_1d%psi(nr))**2)
2059 equilibrium%profiles_2d(1)%jpar(nr - i + 1, 1) = &
2060 (equilibrium%profiles_1d%F_dia(nr - i + 1) &
2061 / equilibrium%coord_sys%position%r(nr - i + 1, 1) &
2062 * equilibrium%profiles_2d(1)%jphi(nr - i + 1, 1) &
2063 + equilibrium%profiles_1d%ffprime(nr - i + 1) &
2064 / equilibrium%profiles_1d%F_dia(nr - i + 1) / (twopi**2 * mu0 &
2065 * equilibrium%coord_sys%position%r(nr - i + 1, 1)**2) &
2066 * equilibrium%coord_sys%g_11(nr - i + 1, 1)) / b_field
2077 no = (i - 1) * nchi + j
2079 if ((cchi(1, (i - 1) * np + k) <= zchi .and. cchi(1, &
2080 (i - 1) * np + k + 1) >= zchi) .or. (j == nchi &
2081 .and. k == np - 1 .and. ias == 0))
then
2085 nom = (i - 1) * np + k
2088 a3 = (cchi(1, nom) + cchi(3, nom) - cchi(1, nop) &
2089 + cchi(3, nop)) / 4._r8
2090 a2 = (-cchi(3, nom) + cchi(3, nop)) / 4._r8
2091 a1 = (-3 * cchi(1, nom) - cchi(3, nom) + 3 * cchi(1, nop) &
2092 - cchi(3, nop)) / 4._r8
2093 a0 = (2 * cchi(1, nom) + cchi(3, nom) + 2 * cchi(1, nop) &
2094 - cchi(3, nop)) / 4._r8 - zchi
2096 call
solve_cubic(a0, a1, a2, a3, s, s2, s3, ifail)
2098 if (ias == 0 .and. j == nchi)
then
2103 if (ifail == 0)
then
2104 n1 = (i - 1) * np + k
2109 equilibrium%profiles_2d(1)%jphi(nr - i + 1, j) = - j0 * eps &
2110 *
rh_side(a, xx(1, n1), 0._r8, 0._r8, 0._r8, 0._r8, &
2111 psi(4 * (n1 - 1) + 1), 0._r8, 0._r8)
2112 f_dia = equilibrium%profiles_1d%F_dia(nr - i + 1) &
2113 * equilibrium%eqgeometry%a_minor &
2114 / equilibrium%profiles_1d%psi(nr)
2115 b_field = sqrt(
b2(a, xx(1, n1), 0._r8, 0._r8, 0._r8, 0._r8, &
2116 psi(4 * (n1 - 1) + 1), 0._r8, f_dia) &
2117 / (equilibrium%eqgeometry%a_minor &
2118 * equilibrium%eqgeometry%geom_axis%r &
2119 / equilibrium%profiles_1d%psi(nr))**2)
2120 equilibrium%profiles_2d(1)%jpar(nr - i + 1, j) = &
2121 (equilibrium%profiles_1d%F_dia(nr - i + 1) &
2122 / equilibrium%coord_sys%position%r(nr - i + 1, j) &
2123 * equilibrium%profiles_2d(1)%jphi(nr - i + 1, j) &
2124 + equilibrium%profiles_1d%ffprime(nr - i + 1) * twopi &
2125 / equilibrium%profiles_1d%F_dia(nr - i + 1) / (twopi**2 * mu0 &
2126 * equilibrium%coord_sys%position%r(nr - i + 1, j)**2) &
2127 * equilibrium%coord_sys%g_11(nr - i + 1, j)) / b_field
2130 if (standard_output) &
2131 write(out_he, *)
'error in solve_cubic i,j,k : ', i, j, k, &
2133 if (verbosity > 3)
then
2134 write(iu6, *) a0, a1, a2, a3, zchi
2135 write(iu6, *) cchi(1, (i - 1) * np + k), cchi(1, (i - 1) &
subroutine write_old_equilibrium(path, equilibrium_out)
subroutine mapping(cx, cy, xaxis, yaxis, a, equilibrium_out)
real(r8) function r_min(rminor, xaxis, i)
subroutine radial_mesh(rpsi, zpsi, dzpsi, ddzpsi)
subroutine plot_data_2d(type_plot, x, y, printname, z)
subroutine profiles(p0, rbphi, dp0, drbphi, a)
real(r8) function b_fun(a, x, xr, xs, yr, ys, psi, psir, F_dia)
type(rz_coordinate) function rz_top(rminor, xaxis, yaxis, i)
type(rz_coordinate) function rz_bottom(rminor, xaxis, yaxis, i)
real(r8) function, dimension(n), public integrate(f_spline, x, n, inv)
subroutine interpolation(type_interp, xn1, xn2, xn3, xn4, r, s, x, xr, xs, xrs, xrr, xss, yn1, yn2, yn3, yn4, pn1, pn2, pn3, pn4, yr, ys, ps)
subroutine output(NGRID, betpol, zli3)
subroutine allocate_spline_coefficients(spline, n)
real(r8) function gradpsi2(a, x, xr, xs, yr, ys, psi, psir, F_dia)
subroutine, public fill_equilibrium(a, xaxis, yaxis, current_averaging, equilibrium)
real(r8) function one_over_r2(a, x, xr, xs, yr, ys, psi, psir, F_dia)
real(r8) function gradpsi(a, x, xr, xs, yr, ys, psi, psir, F_dia)
subroutine spline(N, X, Y, ALFA, BETA, TYP, A, B, C, D)
REAL *8 function spwert(N, XWERT, A, B, C, D, X, ABLTG)
real(r8) function rh_side(a, x, xr, xs, yr, ys, psi, psir, F_dia)
real(r8) function one_over_b2(a, x, xr, xs, yr, ys, psi, psir, F_dia)
real(r8) function dgamma_dpsi(flux)
real(r8) function, public flux_surface_average(i, xaxis, a, F_dia, type, func)
real(r8) function b2(a, x, xr, xs, yr, ys, psi, psir, F_dia)
subroutine plot_data_1d(type_plot, x, y, np, printname, z)
real(r8) function gradrho2_over_b2(a, x, xr, xs, yr, ys, psi, psir, F_dia)
subroutine solve_cubic(c0, c1, c2, c3, x1, x2, x3, ifail)
subroutine deallocate_spline_coefficients(spline)
real(r8) function, public root(a, b, c, d, sgn)
real(r8) function one_over_r(a, x, xr, xs, yr, ys, psi, psir, F_dia)
real(r8) function r_major(a, x, xr, xs, yr, ys, psi, psir, F_dia)
real(r8) function dp_dpsi(flux)
real(r8) function r_max(rminor, xaxis, i)
subroutine current_at_nodes(a, equilibrium)
subroutine ne_te_profile(dt, psi, f, df, const, df_in)
real(r8) function gradpsi2_over_r2(a, x, xr, xs, yr, ys, psi, psir, F_dia)
subroutine pplot(MX, MY, X, Y, NPTS, INC)