24 USE deallocate_structures
33 INTEGER :: nrho=100, irho
34 INTEGER :: nnucl=1, inucl
35 INTEGER :: nion=1, iion
36 INTEGER :: nimp=0, iimp
37 INTEGER,
ALLOCATABLE :: nzimp(:)
39 INTEGER :: nneut=0, ineut
40 INTEGER,
ALLOCATABLE :: ncomp(:)
42 INTEGER,
ALLOCATABLE :: ntype(:)
45 INTEGER :: ndim1=100, idim1
46 INTEGER :: ndim2=100, idim2
48 INTEGER :: ncold=1, nthermal=1, nfast=0, nnbi=0
50 REAL (R8),
ALLOCATABLE :: amn(:)
51 REAL (R8),
ALLOCATABLE :: zn(:)
52 REAL (R8),
ALLOCATABLE :: zion(:)
53 REAL (R8),
ALLOCATABLE :: amn_imp(:)
54 REAL (R8),
ALLOCATABLE :: zn_imp(:)
55 REAL (R8),
ALLOCATABLE :: max_z_imp(:)
57 INTEGER :: cold_neutrals=0
58 INTEGER :: thermal_neutrals=0
59 INTEGER :: fast_neutrals=0
60 INTEGER :: nbi_neutrals=0
62 INTEGER :: force_compositions=0
67 TYPE (type_equilibrium
),
POINTER :: equilibrium(:)
68 TYPE (type_equilibrium
),
POINTER :: equilibrium_ext(:)
70 TYPE (type_compositionc
),
POINTER :: compositionc(:)
71 TYPE (type_compositionc
),
POINTER :: compositionc_ext(:)
73 TYPE (type_coreprof
),
POINTER :: coreprof(:)
74 TYPE (type_coreprof
),
POINTER :: coreprof_comp(:)
75 TYPE (type_coreprof
),
POINTER :: coreprof_ext(:)
76 TYPE (type_coretransp
),
POINTER :: coretransp(:)
77 TYPE (type_coretransp
),
POINTER :: coretransp_ext(:)
78 TYPE (type_coresource
),
POINTER :: coresource(:)
79 TYPE (type_coresource
),
POINTER :: coresource_ext(:)
80 TYPE (type_coreimpur
),
POINTER :: coreimpur(:)
81 TYPE (type_coreimpur
),
POINTER :: coreimpur_ext(:)
82 TYPE (type_wall
),
POINTER :: wall(:)
83 TYPE (type_wall
),
POINTER :: wall_ext(:)
84 TYPE (type_toroidfield
),
POINTER :: toroidfield(:)
85 TYPE (type_toroidfield
),
POINTER :: toroidfield_ext(:)
87 TYPE (type_coreneutrals
),
POINTER :: coreneutrals(:)
88 TYPE (type_coreneutrals
),
POINTER :: coreneutrals_ext(:)
95 INTEGER :: ind, tindex
97 CHARACTER(len=5) :: treename
98 CHARACTER(len=8) :: coreprofpath
99 CHARACTER(len=10) :: coretransppath
100 CHARACTER(len=10) :: coresourcepath
101 CHARACTER(len=9) :: coreimpurpath
102 CHARACTER(len=4) :: wallpath
103 CHARACTER(len=11) :: equilibriumpath
104 CHARACTER(len=11) :: toroidfieldpath
107 CHARACTER(len=12) :: coreneutralspath
108 CHARACTER(len=12) :: compositioncpath
110 CHARACTER(len=256) :: user, machine, ual_version
112 CHARACTER(len=17) :: filename
115 REAL(R8),
ALLOCATABLE :: rho(:)
116 REAL(R8),
ALLOCATABLE :: rhonrm(:)
118 REAL(R8) :: rhox, ipt
119 REAL(R8) :: curr, curr_total
120 REAL(R8),
ALLOCATABLE :: ne(:)
121 REAL(R8),
ALLOCATABLE :: te(:)
122 REAL(R8),
ALLOCATABLE :: ni(:,:)
123 REAL(R8),
ALLOCATABLE :: zi(:,:)
124 REAL(R8),
ALLOCATABLE :: ti(:,:)
125 REAL(R8),
ALLOCATABLE :: vtor(:,:)
126 REAL(R8),
ALLOCATABLE :: jpar(:), intjpar(:)
127 REAL(R8),
ALLOCATABLE :: qsf(:)
128 REAL(R8),
ALLOCATABLE :: pr(:)
129 REAL(R8),
ALLOCATABLE :: psi(:)
130 REAL(R8),
ALLOCATABLE ::
fun(:)
131 REAL(R8),
ALLOCATABLE :: dvdrho(:)
132 REAL(R8),
ALLOCATABLE :: integrated_power(:)
134 LOGICAL :: external_coreprof = .false., external_equilibrium = .false., &
135 external_coresource = .false., external_coretransp = .false., &
136 external_coreimpur = .false., external_toroidfield = .false., &
137 external_coreneutrals = .false., external_compositionc = .false., &
138 external_wall = .false.
146 INTEGER,
PARAMETER :: buflen = 256
148 TYPE (type_param
) :: code_parameters
149 INTEGER :: return_status
151 INTEGER :: shot=0, run=0
152 REAL(R8) :: time=0, r0=0, b0=0, a0=0, ip=0, rgeo=0
153 REAL(R8) :: el=0, tr_u=0, tr_l=0
154 CHARACTER(len=BUFLEN) :: rho_f
155 REAL(R8),
ALLOCATABLE :: rho_1(:), rho_2(:), rho_3(:), rho_4(:)
156 REAL(R8) :: dummy1, dummy2, x
157 CHARACTER(len=BUFLEN),
ALLOCATABLE :: ni_f(:),ti_f(:),vtor_f(:)
158 CHARACTER(len=BUFLEN) :: te_f, jpar_f, qsf_f
159 CHARACTER(len=BUFLEN) :: sigma_f, ne_diff_f(3), ne_conv_f(3)
160 CHARACTER(len=BUFLEN),
ALLOCATABLE :: ni_diff_f(:,:), ni_conv_f(:,:)
161 CHARACTER(len=BUFLEN) :: te_diff_f, te_conv_f
162 CHARACTER(len=BUFLEN),
ALLOCATABLE :: ti_diff_f(:), ti_conv_f(:)
163 CHARACTER(len=BUFLEN),
ALLOCATABLE :: vtor_diff_f(:), vtor_conv_f(:)
164 CHARACTER(len=BUFLEN) :: j_src_f, sigma_src_f, qe_exp_f, qe_imp_f, se_exp_f, se_imp_f
165 CHARACTER(len=BUFLEN),
ALLOCATABLE :: qi_exp_f(:), qi_imp_f(:), si_exp_f(:), si_imp_f(:)
167 CHARACTER(len=BUFLEN),
ALLOCATABLE :: qz_exp_f(:), qz_imp_f(:), sz_exp_f(:), sz_imp_f(:)
168 CHARACTER(len=BUFLEN),
ALLOCATABLE :: ui_exp_f(:), ui_imp_f(:)
170 CHARACTER(len=BUFLEN),
ALLOCATABLE :: imp_nz_f(:), imp_diff_f(:), imp_conv_f(:)
172 CHARACTER(len=80) :: equilibrium_external=
'', coreprof_external=
'', coreneutrals_external=
'',compositionc_external=
'',&
173 coretransp_external=
'',coresource_external=
'', coreimpur_external=
'', toroidfield_external=
'', &
174 tmp_external, wall_external=
''
176 CHARACTER(len=80) :: prepare_input_cpos_xml =
'prepare_input_cpos_1.xml'
179 INTEGER :: inneut,imax_ntype,imax_comp
181 INTEGER :: shot_in, run_in
184 LOGICAL :: l_ext_current
186 l_ext_current =.false.
188 IF(iargc().GT.0)
THEN
189 CALL getarg(1,prepare_input_cpos_xml)
192 CALL fill_param(code_parameters, trim(prepare_input_cpos_xml),
'',
'XML/prepare_input_cpos.xsd')
196 nzimp, ncomp, ntype, &
200 amn_imp, zn_imp, max_z_imp, &
205 IF(rgeo == 0) rgeo = r0
207 WRITE(*,*)
'EXTERNAL_COREPROF = ', external_coreprof
208 WRITE(*,*)
' NRHO = ', nrho
209 WRITE(*,*)
' NION = ', nion
210 WRITE(*,*)
' NIMP = ', nimp
211 IF(
ALLOCATED(nzimp)) &
212 WRITE(*,*)
' NZIMP = ', nzimp
213 WRITE(*,*)
' NDIM1 = ', ndim1
214 WRITE(*,*)
' NDIM2 = ', ndim2
215 WRITE(*,*)
' NPOINTS = ', npoints
218 WRITE(*,*)
' NNEUT = ', nneut
219 IF(
ALLOCATED(ncomp)) &
220 WRITE(*,*)
' NCOMP = ', ncomp
221 IF(
ALLOCATED(ntype)) &
222 WRITE(*,*)
' NTYPE = ', ntype
224 WRITE(*,*)
' SHOT = ', shot
225 WRITE(*,*)
' RUN = ', run
226 WRITE(*,*)
' EL = ', el
227 WRITE(*,*)
' TR_U = ', tr_u
228 WRITE(*,*)
' TR_L = ', tr_l
229 WRITE(*,*)
' AMN = ', amn
230 WRITE(*,*)
' ZN = ', zn
231 WRITE(*,*)
' ZION = ', zion
232 IF(.NOT.external_coreprof)
THEN
234 WRITE(*,*)
' NI_F ',iion,
' : ',trim(ni_f(iion))
236 WRITE(*,*)
' TE_F ', 0,
' : ', trim(te_f)
238 WRITE(*,*)
' TI_F ',iion,
' : ',trim(ti_f(iion))
241 WRITE(*,*)
'VTOR_F ',iion,
' : ',trim(vtor_f(iion))
245 WRITE(*,*)
' AMN_IMP = ', amn_imp
246 WRITE(*,*)
' ZN_IMP = ', zn_imp
255 IF(external_equilibrium)
THEN
256 CALL
parse_external(equilibrium_external, shot_in, run_in, user, machine, ual_version)
258 equilibriumpath =
'equilibrium'
259 CALL
euitm_open_env(treename,shot_in,run_in,idx,trim(user),trim(machine),trim(ual_version))
260 CALL euitm_get(idx,
"equilibrium", equilibrium_ext)
262 WRITE(*,*)
'1: input equilibrium B0 ', equilibrium_ext(1)%global_param%toroid_field%b0
264 WRITE(*,*)
'2: input equilibrium B0 ', equilibrium_ext(1)%global_param%toroid_field%b0
268 IF(external_coreprof)
THEN
269 CALL
parse_external(coreprof_external, shot_in, run_in, user, machine, ual_version)
271 coreprofpath =
'coreprof'
272 CALL
euitm_open_env(treename,shot_in,run_in,idx,trim(user),trim(machine),trim(ual_version))
273 CALL euitm_get(idx,
"coreprof", coreprof_ext)
274 nrho =
SIZE (coreprof_ext(1)%rho_tor, dim=1)
275 IF(
ASSOCIATED(coreprof_ext(1)%composition%amn))
THEN
276 nion =
SIZE (coreprof_ext(1)%compositions%ions)
277 ALLOCATE(zn(nion),amn(nion),zion(nion))
278 zn = coreprof_ext(1)%composition%zn
279 amn = coreprof_ext(1)%composition%amn
280 zion = coreprof_ext(1)%composition%zion
283 WRITE(*,*)
'Assuming 1 one species, D'
284 ALLOCATE(zn(nion),amn(nion),zion(nion))
292 IF(external_coresource)
THEN
293 CALL
parse_external(coresource_external, shot_in, run_in, user, machine, ual_version)
295 coresourcepath =
'coresource'
296 CALL
euitm_open_env(treename,shot_in,run_in,idx,trim(user),trim(machine),trim(ual_version))
297 CALL euitm_get(idx,
"coresource", coresource_ext)
299 IF(external_coretransp)
THEN
300 CALL
parse_external(coretransp_external, shot_in, run_in, user, machine, ual_version)
302 coretransppath =
'coretransp'
303 CALL
euitm_open_env(treename,shot_in,run_in,idx,trim(user),trim(machine),trim(ual_version))
304 CALL euitm_get(idx,
"coretransp", coretransp_ext)
306 IF(external_coreimpur)
THEN
307 CALL
parse_external(coreimpur_external, shot_in, run_in, user, machine, ual_version)
309 coreimpurpath =
'coreimpur'
310 CALL
euitm_open_env(treename,shot_in,run_in,idx,trim(user),trim(machine),trim(ual_version))
311 CALL euitm_get(idx,
"coreimpur", coreimpur_ext)
313 IF(external_wall)
THEN
314 CALL
parse_external(wall_external, shot_in, run_in, user, machine, ual_version)
317 CALL
euitm_open_env(treename,shot_in,run_in,idx,trim(user),trim(machine),trim(ual_version))
318 CALL euitm_get(idx,
"wall", wall_ext)
321 IF(external_coreneutrals)
THEN
322 CALL
parse_external(coreneutrals_external, shot_in, run_in, user, machine, ual_version)
324 coreneutralspath =
'coreneutrals'
325 CALL
euitm_open_env(treename,shot_in,run_in,idx,trim(user),trim(machine),trim(ual_version))
326 CALL euitm_get(idx,
"coreneutrals", coreneutrals_ext)
329 IF(external_compositionc)
THEN
330 CALL
parse_external(compositionc_external, shot_in, run_in, user, machine, ual_version)
332 compositioncpath =
'compositionc'
333 CALL
euitm_open_env(treename,shot_in,run_in,idx,trim(user),trim(machine),trim(ual_version))
334 CALL euitm_get(idx,
"compositionc", compositionc_ext)
339 IF(external_toroidfield)
THEN
340 CALL
parse_external(toroidfield_external, shot_in, run_in, user, machine, ual_version)
342 toroidfieldpath =
'toroidfield'
343 CALL
euitm_open_env(treename,shot_in,run_in,idx,trim(user),trim(machine),trim(ual_version))
344 CALL euitm_get(idx,
"toroidfield", toroidfield_ext)
347 IF(external_equilibrium.OR.external_coreprof.OR.external_coresource.OR.external_coretransp.OR. &
348 external_coreimpur.OR.external_toroidfield.OR.external_wall)
THEN
349 WRITE(*,*)
'No UAL available at compile time'
354 ALLOCATE ( rho(nrho) )
355 ALLOCATE ( rhonrm(nrho) )
356 ALLOCATE ( ne(nrho) )
357 ALLOCATE ( te(nrho) )
358 ALLOCATE ( qsf(nrho) )
359 ALLOCATE ( jpar(nrho) )
360 ALLOCATE ( intjpar(nrho) )
361 ALLOCATE ( ni(nrho,nion) )
362 ALLOCATE ( zi(nrho,nion) )
363 ALLOCATE ( ti(nrho,nion) )
364 ALLOCATE ( vtor(nrho,nion) )
365 ALLOCATE ( pr(nrho) )
366 ALLOCATE ( psi(nrho) )
367 ALLOCATE (
fun(nrho) )
368 ALLOCATE ( dvdrho(nrho) )
369 ALLOCATE ( integrated_power(nrho))
386 IF(external_coreprof)
THEN
387 rhob = coreprof_ext(1)%rho_tor(nrho)
388 ELSE IF (external_equilibrium)
THEN
389 rhob = equilibrium_ext(1)%profiles_1d%rho_tor(
size(equilibrium_ext(1)%profiles_1d%rho_tor))
395 IF(external_coreprof)
THEN
396 rho = coreprof_ext(1)%rho_tor
397 rhonrm = rho/rho(nrho)
399 ALLOCATE(rho_1(0:10*nrho), rho_2(0:10*nrho), rho_3(0:10*nrho), rho_4(nrho))
407 CALL
cubint(10*nrho+1, rho_1, rho_2, 1, i+1, rho_3(i), dummy1)
409 rho_3=rho_3/rho_3(10*nrho)
410 rho_4 = (/ (1.0_r8/(nrho-1) * (irho-1), irho=1,nrho) /)
411 CALL
l3interp(rho_1, rho_3, 10*nrho+1, rhonrm, rho_4, nrho)
412 DEALLOCATE(rho_1, rho_2, rho_3, rho_4)
415 rhox = max(sqrt(el), 1.0_r8)
417 IF(external_coreprof)
THEN
418 jpar = coreprof_ext(1)%profiles1d%jtot%value
419 pr = coreprof_ext(1)%profiles1d%pr_perp%value
420 qsf = coreprof_ext(1)%profiles1d%q%value
422 IF (trim(jpar_f) ==
'0.0' .AND. (external_equilibrium))
THEN
423 CALL
l3interp(equilibrium_ext(1)%profiles_1d%jparallel, equilibrium_ext(1)%profiles_1d%rho_tor,
size(equilibrium_ext(1)%profiles_1d%rho_tor), &
425 CALL
l3interp(equilibrium_ext(1)%profiles_1d%psi, equilibrium_ext(1)%profiles_1d%rho_tor,
size(equilibrium_ext(1)%profiles_1d%rho_tor), &
427 l_ext_current =.true.
432 IF (trim(qsf_f) ==
'0.0'.AND. (external_equilibrium))
THEN
433 CALL
l3interp(equilibrium_ext(1)%profiles_1d%q, equilibrium_ext(1)%profiles_1d%rho_tor,
size(equilibrium_ext(1)%profiles_1d%rho_tor), &
443 ni(:,iion) =
profile(ni_f(iion),rhonrm)
444 ti(:,iion) =
profile(ti_f(iion),rhonrm)
445 vtor(:,iion) =
profile(vtor_f(iion),rhonrm)
446 ne = ne + ni(:,iion) * zion(iion)
447 pr = pr + ni(:,iion) * ti(:,iion)
450 pr = (pr + ne * te) * itm_ev
459 IF (.NOT. l_ext_current)
THEN
463 CALL
integral(nrho, rho, jpar, intjpar)
466 rho_loop2:
DO irho =1,nrho
467 IF(intjpar(irho).NE.0.e0_r8)
THEN
468 qsf(irho) = -rho(irho)**2*b0/r0/1.25e-6_r8/intjpar(irho)
472 IF (qsf(irho).NE.0.e0_r8)
THEN
473 fun(irho) = 2.e0_r8*itm_pi*b0/qsf(irho)
480 fun = jpar*4.e0_r8*itm_pi**2*rho*r0
482 curr = intjpar(nrho)/(2.e0_r8*itm_pi*r0)
485 IF (dabs(1.0_r8 - curr/ipt) .GE. 1.0e-5_r8)
THEN
486 jpar = jpar * ipt / curr
491 WRITE (6,*)
'TOTAL CURRENT NORMALISED TO', curr
499 IF (external_equilibrium)
THEN
500 CALL
l3interp(equilibrium_ext(1)%profiles_1d%dvdrho, equilibrium_ext(1)%profiles_1d%rho_tor,
size(equilibrium_ext(1)%profiles_1d%rho_tor), &
507 IF(.NOT.external_coreprof)
THEN
508 coreprof(1)%time = time
509 coreprof(1)%datainfo%cocos = 13
510 coreprof(1)%toroid_field%r0 = r0
511 coreprof(1)%toroid_field%b0 = b0
512 coreprof(1)%globalparam%current_tot = ip
513 coreprof(1)%rho_tor = rho
514 coreprof(1)%rho_tor_norm = rhonrm
515 coreprof(1)%profiles1d%jtot%value = jpar
516 coreprof(1)%profiles1d%q%value = qsf
517 coreprof(1)%psi%value = psi
518 coreprof(1)%ne%value = ne
519 coreprof(1)%te%value = te
520 coreprof(1)%ni%value = ni
521 coreprof(1)%ti%value = ti
522 coreprof(1)%vtor%value = vtor
523 coreprof(1)%profiles1d%pr_th%value = pr
524 coreprof(1)%profiles1d%pr_perp%value = pr
525 coreprof(1)%profiles1d%pr_parallel%value = pr
526 coreprof(1)%profiles1d%pe%value = ne*te * itm_ev
527 coreprof(1)%profiles1d%pi%value = ni*ti * itm_ev
528 coreprof(1)%psi%sigma_par%value = 0.0_r8
532 coreprof(1)%psi%boundary%value = 0
533 coreprof(1)%ne%boundary%value = 0
534 coreprof(1)%te%boundary%value = 0
535 coreprof(1)%ni%boundary%value = 0
536 coreprof(1)%ti%boundary%value = 0
537 coreprof(1)%vtor%boundary%value = 0
539 coreprof(1)%psi%boundary%type = 2
540 coreprof(1)%psi%boundary%value(1) = coreprof(1)%globalparam%current_tot
541 coreprof(1)%psi%boundary%rho = rho(nrho)
543 coreprof(1)%ne%boundary%type = 1
544 coreprof(1)%ne%boundary%value(1) = coreprof(1)%ne%value(nrho)
545 coreprof(1)%ne%boundary%rho_tor = rho(nrho)
547 coreprof(1)%te%boundary%type = 1
548 coreprof(1)%te%boundary%value(1) = coreprof(1)%te%value(nrho)
549 coreprof(1)%te%boundary%rho_tor = rho(nrho)
552 coreprof(1)%ni%boundary%type(iion) = 1
553 coreprof(1)%ni%boundary%value(1,iion) = coreprof(1)%ni%value(nrho,iion)
554 coreprof(1)%ni%boundary%rho_tor(iion) = rho(nrho)
556 coreprof(1)%ti%boundary%type(iion) = 1
557 coreprof(1)%ti%boundary%value(1,iion) = coreprof(1)%ti%value(nrho,iion)
558 coreprof(1)%ti%boundary%rho_tor(iion) = rho(nrho)
560 coreprof(1)%vtor%boundary%type(iion) = 1
561 coreprof(1)%vtor%boundary%value(1,iion) = coreprof(1)%vtor%value(nrho,iion)
562 coreprof(1)%vtor%boundary%rho_tor(iion) = rho(nrho)
570 coreprof(1)%profiles1d%zeff%value(irho) = 0.0_r8
572 coreprof(1)%profiles1d%zeff%value(irho) = coreprof(1)%profiles1d%zeff%value(irho) + &
573 coreprof(1)%compositions%ions(iion)%zion**2 * coreprof(1)%ni%value(irho,iion)
575 coreprof(1)%profiles1d%zeff%value(irho) = coreprof(1)%profiles1d%zeff%value(irho) / coreprof(1)%ne%value(irho)
578 IF(.NOT.
ASSOCIATED(coreprof_ext(1)%psi%sigma_par%value))
THEN
579 ALLOCATE(coreprof_ext(1)%psi%sigma_par%value(nrho))
580 coreprof_ext(1)%psi%sigma_par%value= 0.0_r8
590 coretransp(1)%time = time
591 coretransp(1)%datainfo%cocos = 13
592 coretransp(1)%VALUES(1)%rho_tor_norm = rhonrm
593 coretransp(1)%VALUES(1)%rho_tor = rho
594 coretransp(1)%VALUES(1)%sigma =
profile(sigma_f,rhonrm)
597 coretransp(1)%VALUES(1)%ne_transp%diff_eff(:,tindex) =
profile(ne_diff_f(tindex),rhonrm)
598 coretransp(1)%VALUES(1)%ne_transp%vconv_eff(:,tindex) =
profile(ne_conv_f(tindex),rhonrm)
600 coretransp(1)%VALUES(1)%ni_transp%diff_eff(:,iion,tindex) =
profile(ni_diff_f(tindex,iion),rhonrm)
601 coretransp(1)%VALUES(1)%ni_transp%vconv_eff(:,iion,tindex) =
profile(ni_conv_f(tindex,iion),rhonrm)
605 coretransp(1)%VALUES(1)%te_transp%diff_eff(:) =
profile(te_diff_f,rhonrm)
606 coretransp(1)%VALUES(1)%te_transp%vconv_eff(:) =
profile(te_conv_f,rhonrm)
609 coretransp(1)%VALUES(1)%ti_transp%diff_eff(:,iion) =
profile(ti_diff_f(iion),rhonrm)
610 coretransp(1)%VALUES(1)%ti_transp%vconv_eff(:,iion) =
profile(ti_conv_f(iion),rhonrm)
611 coretransp(1)%VALUES(1)%vtor_transp%diff_eff(:,iion) =
profile(vtor_diff_f(iion),rhonrm)
612 coretransp(1)%VALUES(1)%vtor_transp%vconv_eff(:,iion) =
profile(vtor_conv_f(iion),rhonrm)
618 WRITE(*,*)
'nint(ZN_IMP(IIMP))=',nint(zn_imp(iimp))
619 WRITE(*,*)
'NIMP=',nimp
621 DO izimp = 1, nzimp(iimp)
623 coretransp(1)%VALUES(1)%nz_transp(iimp)%DIFF_EFF(:,izimp) =
profile(imp_diff_f(ind),rhonrm)
624 coretransp(1)%VALUES(1)%nz_transp(iimp)%VCONV_EFF(:,izimp) =
profile(imp_conv_f(ind),rhonrm)
634 coresource(1)%time = time
635 coresource(1)%datainfo%cocos = 13
636 coresource(1)%VALUES(1)%rho_tor_norm = rhonrm
637 coresource(1)%VALUES(1)%rho_tor = rho
638 coresource(1)%VALUES(1)%j(:) =
profile(j_src_f,rhonrm)
639 coresource(1)%values(1)%sigma =
profile(sigma_src_f,rhonrm)
640 coresource(1)%VALUES(1)%qe%exp(:) =
profile(qe_exp_f,rhonrm)
641 coresource(1)%VALUES(1)%qe%imp(:) =
profile(qe_imp_f,rhonrm)
642 coresource(1)%VALUES(1)%se%exp(:) =
profile(se_exp_f,rhonrm)
643 coresource(1)%VALUES(1)%se%imp(:) =
profile(se_imp_f,rhonrm)
645 write(6,*)
'SI_EXP_F ', si_exp_f(iion)
646 coresource(1)%VALUES(1)%si%exp(:,iion) =
profile(si_exp_f(iion),rhonrm)
647 coresource(1)%VALUES(1)%si%imp(:,iion) =
profile(si_imp_f(iion),rhonrm)
648 coresource(1)%VALUES(1)%qi%exp(:,iion) =
profile(qi_exp_f(iion),rhonrm)
649 coresource(1)%VALUES(1)%qi%imp(:,iion) =
profile(qi_imp_f(iion),rhonrm)
650 coresource(1)%VALUES(1)%ui%exp(:,iion) =
profile(ui_exp_f(iion),rhonrm)
651 coresource(1)%VALUES(1)%ui%imp(:,iion) =
profile(ui_imp_f(iion),rhonrm)
656 IF (external_equilibrium)
THEN
657 fun(:) = coresource(1)%values(1)%qe%exp(:)*dvdrho(:)
659 fun(:) =
fun(:) + coresource(1)%values(1)%qi%exp(:, iion)*dvdrho(:)
664 write(*,*)
'Total power: ', integrated_power(nrho)
670 WRITE(*,*)
'nint(ZN_IMP(IIMP))=',nint(zn_imp(iimp))
672 DO izimp = 1,nint(zn_imp(iimp))
674 coresource(1)%VALUES(1)%sz(iimp)%exp(:,izimp) =
profile(sz_exp_f(izimp),rhonrm)
691 coreimpur(1)%time = time
692 coreimpur(1)%datainfo%cocos = 13
694 coreimpur(1)%rho_tor_norm = rhonrm
695 coreimpur(1)%rho_tor = rho
703 WRITE(*,*)
'nint(ZN_IMP(IIMP))=',nint(zn_imp(iimp))
704 WRITE(*,*)
'NIMP=',nimp
706 DO izimp = 1, nzimp(iimp)
710 coreimpur(1)%impurity(iimp)%z(:,izimp) = izimp
711 coreimpur(1)%impurity(iimp)%zsq(:,izimp) = izimp**2
712 coreimpur(1)%impurity(iimp)%nz(:,izimp) =
profile(imp_nz_f(ind),rhonrm)
715 coreimpur(1)%impurity(iimp)%BOUNDARY%TYPE(izimp) = 1
716 coreimpur(1)%impurity(iimp)%BOUNDARY%RHO(izimp) = rho(nrho)
717 coreimpur(1)%IMPURITY(iimp)%BOUNDARY%VALUE(1,izimp) = coreimpur(1)%IMPURITY(iimp)%nz(nrho,izimp)
730 coreneutrals(1)%time = time
731 coreneutrals(1)%datainfo%cocos = 13
732 coreneutrals(1)%rho_tor = rho
733 coreneutrals(1)%rho_tor_norm = rhonrm
734 IF(nneut .GT. 0 )
THEN
751 DO itype=1,ntype(ineut)
752 coreneutrals(1)%profiles(ineut)%neutraltype(itype)%n0%boundary%type =1.
753 coreneutrals(1)%profiles(ineut)%neutraltype(itype)%n0%boundary%rho_tor =rho(nrho)
754 coreneutrals(1)%profiles(ineut)%neutraltype(itype)%t0%boundary%type =1.
755 coreneutrals(1)%profiles(ineut)%neutraltype(itype)%t0%boundary%rho_tor =rho(nrho)
759 coreneutrals(1)%profiles(1)%neutraltype(1)%t0%value(:) = 1.0_r8
760 coreneutrals(1)%profiles(1)%neutraltype(2)%t0%value(:) = 100.0_r8
761 coreneutrals(1)%profiles(2)%neutraltype(1)%t0%value(:) = 1.0_r8
762 coreneutrals(1)%profiles(2)%neutraltype(2)%t0%value(:) = 100.0_r8
766 coreneutrals(1)%profiles(1)%neutraltype(1)%n0%value(nrho) = 1.0e+16_r8
767 coreneutrals(1)%profiles(2)%neutraltype(2)%n0%value(nrho) = 0.0_r8
768 coreneutrals(1)%profiles(1)%neutraltype(1)%n0%value(nrho) = 1.0e+3_r8
769 coreneutrals(1)%profiles(2)%neutraltype(2)%n0%value(nrho) = 0.0_r8
770 coreneutrals(1)%profiles(1)%neutraltype(1)%n0%boundary%value(3) = 1.0e+16_r8
771 coreneutrals(1)%profiles(1)%neutraltype(2)%n0%boundary%value(3) = 0.0_r8
772 coreneutrals(1)%profiles(2)%neutraltype(1)%n0%boundary%value(3) = 1.0e+3_r8
773 coreneutrals(1)%profiles(2)%neutraltype(2)%n0%boundary%value(3) = 0.0_r8
774 coreneutrals(1)%profiles(1)%neutraltype(1)%t0%boundary%value(3) = 1._r8
775 coreneutrals(1)%profiles(1)%neutraltype(2)%t0%boundary%value(3) = 100.0_r8
776 coreneutrals(1)%profiles(2)%neutraltype(1)%t0%boundary%value(3) = 1.0_r8
777 coreneutrals(1)%profiles(2)%neutraltype(2)%t0%boundary%value(3) = 100.0_r8
786 if(.not.external_equilibrium)
then
787 if(npsi .NE. nrho)
then
788 write(*,*)
' NPSI != NRHO '
789 stop
'Error: NPSI != NRHO'
791 equilibrium(1)%time = time
792 equilibrium(1)%datainfo%cocos = 13
793 equilibrium(1)%global_param%i_plasma = ip
794 equilibrium(1)%global_param%toroid_field%r0 = r0
795 equilibrium(1)%global_param%toroid_field%b0 = b0
796 equilibrium(1)%eqgeometry%geom_axis%r = r0
797 equilibrium(1)%eqgeometry%geom_axis%z = 0.0_r8
798 equilibrium(1)%global_param%mag_axis%position%r = rgeo
799 equilibrium(1)%global_param%mag_axis%position%z = 0.0_r8
800 equilibrium(1)%global_param%mag_axis%bphi = r0*b0/rgeo
801 equilibrium(1)%global_param%mag_axis%q = qsf(1)
803 equilibrium(1)%profiles_1d%rho_tor = rho
804 equilibrium(1)%profiles_1d%q = qsf
805 equilibrium(1)%profiles_1d%pressure = pr
806 equilibrium(1)%profiles_1d%jparallel = jpar
807 equilibrium(1)%eqgeometry%elongation = el
808 equilibrium(1)%eqgeometry%tria_upper = tr_u
809 equilibrium(1)%eqgeometry%tria_lower = tr_l
810 equilibrium(1)%eqgeometry%a_minor = a0
812 equilibrium(1)%profiles_1d%gm1 = 4.e0_r8*itm_pi**2*rho/r0
813 equilibrium(1)%profiles_1d%gm2 = 1.e0_r8/r0**2
814 equilibrium(1)%profiles_1d%gm3 = 1.e0_r8
815 equilibrium(1)%profiles_1d%gm4 = 1.e0_r8/b0**2
816 equilibrium(1)%profiles_1d%gm5 = b0**2
817 equilibrium(1)%profiles_1d%gm6 = 4.e0_r8*itm_pi**2*rho*r0/b0**2
818 equilibrium(1)%profiles_1d%gm7 = 1.e0_r8
819 equilibrium(1)%profiles_1d%volume = 2.e0_r8*itm_pi**2*rho**2*r0
821 equilibrium(1)%profiles_1d%vprime = 4.e0_r8*itm_pi**2*rho*r0
822 equilibrium(1)%profiles_1d%area = itm_pi*rho**2
823 equilibrium(1)%profiles_1d%aprime = 4.e0_r8*itm_pi**2*r0
824 equilibrium(1)%profiles_1d%F_dia = b0*r0
825 equilibrium(1)%profiles_1d%rho_vol = sqrt(equilibrium(1)%profiles_1d%volume/equilibrium(1)%profiles_1d%volume(nrho))
827 equilibrium(1)%profiles_1d%elongation = el
828 equilibrium(1)%profiles_1d%tria_upper = tr_u
829 equilibrium(1)%profiles_1d%tria_lower = tr_l
830 equilibrium(1)%profiles_1d%r_inboard = rgeo - rho/rhox
831 equilibrium(1)%profiles_1d%r_outboard = rgeo + rho/rhox
833 equilibrium(1)%profiles_1d%psi = psi
834 equilibrium(1)%profiles_1d%phi = rho**2 * itm_pi * b0
836 equilibrium(1)%global_param%volume = equilibrium(1)%profiles_1d%volume(nrho)
837 equilibrium(1)%global_param%area = equilibrium(1)%profiles_1d%area(nrho)
841 theta=
REAL(idim2-1,r8)/
REAL(ndim2,r8)*2.0_r8*itm_pi
843 equilibrium(1)%coord_sys%position%R(idim1, idim2) = rgeo + &
844 rho(nrho)*idim1/ndim1/rhox * (cos(theta)-0.5_r8*(tr_u+tr_l)*(sin(theta))**2)
845 equilibrium(1)%coord_sys%position%Z(idim1, idim2) = rho(nrho)*idim1/ndim1/rhox * el * sin(theta)
850 theta=
REAL(i-1,r8)/
REAL(npoints)*2.0_r8*itm_pi
851 equilibrium(1)%eqgeometry%boundary(1)%r(i) = rgeo + &
852 rho(nrho)/rhox * (cos(theta)-0.5_r8*(tr_u+tr_l)*(sin(theta))**2)
853 equilibrium(1)%eqgeometry%boundary(1)%z(i) = rho(nrho)/rhox * el * sin(theta)
856 equilibrium(1)%codeparam%output_flag = 0
867 toroidfield(1)%time = time
868 toroidfield(1)%datainfo%cocos = 13
869 toroidfield(1)%r0 = r0
870 toroidfield(1)%current%value = ip
871 toroidfield(1)%bvac_r%value = b0*r0
884 CALL
allocate_coreprof_cpo(nslice, nrho, nnucl, nion, nimp, nzimp, nneut, ntype, ncomp, coreprof_comp)
888 amn_imp, zn_imp, max_z_imp, &
890 ncold, nthermal, nfast, nnbi)
892 call deallocate_cpo(coreprof(1)%COMPOSITIONS)
893 CALL copy_cpo(coreprof_comp(1)%COMPOSITIONS, coreprof(1)%COMPOSITIONS)
894 call deallocate_cpo(coretransp(1)%COMPOSITIONS)
895 CALL copy_cpo(coreprof_comp(1)%COMPOSITIONS, coretransp(1)%COMPOSITIONS)
896 call deallocate_cpo(coresource(1)%COMPOSITIONS)
897 CALL copy_cpo(coreprof_comp(1)%COMPOSITIONS, coresource(1)%COMPOSITIONS)
898 call deallocate_cpo(coreimpur(1)%COMPOSITIONS)
899 CALL copy_cpo(coreprof_comp(1)%COMPOSITIONS, coreimpur(1)%COMPOSITIONS)
900 call deallocate_cpo(coreneutrals(1)%COMPOSITIONS)
901 CALL copy_cpo(coreprof_comp(1)%COMPOSITIONS, coreneutrals(1)%COMPOSITIONS)
902 call deallocate_cpo(compositionc(1)%COMPOSITIONS)
903 CALL copy_cpo(coreprof_comp(1)%COMPOSITIONS, compositionc(1)%COMPOSITIONS)
906 IF (force_compositions.EQ.1)
THEN
908 IF(external_coreprof)
THEN
909 DO i=1,
SIZE(coreprof_ext)
910 call deallocate_cpo(coreprof_ext(i)%COMPOSITIONS)
911 CALL copy_cpo(coreprof_comp(1)%COMPOSITIONS, coreprof_ext(i)%COMPOSITIONS)
914 IF(external_coretransp)
then
915 call deallocate_cpo(coretransp_ext(1)%COMPOSITIONS)
916 CALL copy_cpo(coreprof_comp(1)%COMPOSITIONS, coretransp_ext(1)%COMPOSITIONS)
918 IF(external_coresource)
then
919 call deallocate_cpo(coresource_ext(1)%COMPOSITIONS)
920 CALL copy_cpo(coreprof_comp(1)%COMPOSITIONS, coresource_ext(1)%COMPOSITIONS)
922 IF(external_coreimpur)
then
923 call deallocate_cpo(coreimpur_ext(1)%COMPOSITIONS)
924 CALL copy_cpo(coreprof_comp(1)%COMPOSITIONS, coreimpur_ext(1)%COMPOSITIONS)
926 IF(external_coreneutrals)
then
927 call deallocate_cpo(coreneutrals_ext(1)%COMPOSITIONS)
928 CALL copy_cpo(coreprof_comp(1)%COMPOSITIONS, coreneutrals_ext(1)%COMPOSITIONS)
939 coreprofpath =
'coreprof'
940 coretransppath =
'coretransp'
941 coresourcepath =
'coresource'
942 coreimpurpath =
'coreimpur'
945 coreneutralspath =
'coreneutrals'
946 compositioncpath =
'compositionc'
948 equilibriumpath =
'equilibrium'
949 toroidfieldpath =
'toroidfield'
951 WRITE(filename,
'(''CPO_'',I6.6,''_'',I6.6)') shot, run
952 CALL open_write_file(1, filename)
953 IF(external_coreprof)
THEN
954 CALL write_cpo(coreprof_ext(1),
'coreprof')
956 CALL write_cpo(coreprof(1),
'coreprof')
958 IF(external_coretransp)
THEN
959 CALL write_cpo(coretransp_ext(1),
'coretransp')
961 CALL write_cpo(coretransp(1),
'coretransp')
963 IF(external_coresource)
THEN
964 CALL write_cpo(coresource_ext(1),
'coresource')
966 CALL write_cpo(coresource(1),
'coresource')
968 IF(external_coreimpur)
THEN
969 CALL write_cpo(coreimpur_ext(1),
'coreimpur')
971 CALL write_cpo(coreimpur(1),
'coreimpur')
974 IF(external_coreneutrals)
THEN
975 CALL write_cpo(coreneutrals_ext(1),
'coreneutrals')
977 CALL write_cpo(coreneutrals(1),
'coreneutrals')
979 IF(external_compositionc)
THEN
980 CALL write_cpo(compositionc_ext(1),
'compositionc')
982 CALL write_cpo(compositionc(1),
'compositionc')
985 IF(external_equilibrium)
THEN
986 CALL write_cpo(equilibrium_ext(1),
'equilibrium')
988 CALL write_cpo(equilibrium(1),
'equilibrium')
990 IF(external_toroidfield)
THEN
991 CALL write_cpo(toroidfield_ext(1),
'toroidfield')
993 CALL write_cpo(toroidfield(1),
'toroidfield')
995 CALL close_write_file
999 WRITE(tmp_external,
'(i,''/'',i)') shot, run
1000 WRITE(*,*) tmp_external
1001 CALL
parse_external(tmp_external, shot_in, run_in, user, machine, ual_version)
1002 WRITE(*,*) shot_in, run_in, trim(user), trim(machine), trim(ual_version)
1004 coreprofpath =
'coreprof'
1005 CALL euitm_create_env(treename,shot_in,run_in,refshot,refrun, idx,trim(user),trim(machine),trim(ual_version))
1007 IF(external_coreprof)
THEN
1008 CALL euitm_put_non_timed(idx, coreprofpath, coreprof_ext(1) )
1009 CALL euitm_put_slice(idx, coreprofpath, coreprof_ext(1) )
1011 CALL euitm_put_non_timed(idx, coreprofpath, coreprof(1) )
1012 CALL euitm_put_slice(idx, coreprofpath, coreprof(1) )
1015 print *,
'==============================================================='
1016 print *,
'>>>>>>>>>>>>>> COREPROF FINISHED'
1017 print *,
'==============================================================='
1020 IF(external_coretransp)
THEN
1021 CALL euitm_put_non_timed(idx, coretransppath, coretransp_ext(1))
1022 CALL euitm_put_slice(idx, coretransppath, coretransp_ext(1))
1024 CALL euitm_put_non_timed(idx, coretransppath, coretransp(1))
1025 CALL euitm_put_slice(idx, coretransppath, coretransp(1))
1027 print *,
'==============================================================='
1028 print *,
'>>>>>>>>>>>>>> CORETRANSP FINISHED'
1029 print *,
'==============================================================='
1032 IF(external_coresource)
THEN
1033 CALL euitm_put_non_timed(idx, coresourcepath, coresource_ext(1))
1034 CALL euitm_put_slice(idx, coresourcepath, coresource_ext(1))
1036 CALL euitm_put_non_timed(idx, coresourcepath, coresource(1))
1037 CALL euitm_put_slice(idx, coresourcepath, coresource(1))
1039 print *,
'==============================================================='
1040 print *,
'>>>>>>>>>>>>>> CORESOURCE FINISHED'
1041 print *,
'==============================================================='
1044 IF(external_coreimpur)
THEN
1045 CALL euitm_put_non_timed(idx, coreimpurpath, coreimpur_ext(1))
1046 CALL euitm_put_slice(idx, coreimpurpath, coreimpur_ext(1))
1048 CALL euitm_put_non_timed(idx, coreimpurpath, coreimpur(1))
1049 CALL euitm_put_slice(idx, coreimpurpath, coreimpur(1))
1051 print *,
'==============================================================='
1052 print *,
'>>>>>>>>>>>>>> COREIMPUR FINISHED'
1053 print *,
'==============================================================='
1057 IF(external_coreneutrals)
THEN
1058 CALL euitm_put_non_timed(idx, coreneutralspath, coreneutrals_ext(1))
1059 CALL euitm_put_slice(idx, coreneutralspath, coreneutrals_ext(1))
1061 CALL euitm_put_non_timed(idx, coreneutralspath, coreneutrals(1))
1062 CALL euitm_put_slice(idx, coreneutralspath, coreneutrals(1))
1064 print *,
'==============================================================='
1065 print *,
'>>>>>>>>>>>>>> CORENEUTRALS FINISHED'
1066 print *,
'==============================================================='
1070 IF(external_equilibrium)
THEN
1071 CALL euitm_put_non_timed(idx, equilibriumpath, equilibrium_ext(1))
1072 CALL euitm_put_slice(idx, equilibriumpath, equilibrium_ext(1))
1074 CALL euitm_put_non_timed(idx, equilibriumpath, equilibrium(1))
1075 CALL euitm_put_slice(idx, equilibriumpath, equilibrium(1))
1077 print *,
'==============================================================='
1078 print *,
'>>>>>>>>>>>>>> EQUILIBRIUM FINISHED'
1079 print *,
'==============================================================='
1082 IF(external_toroidfield)
THEN
1083 CALL euitm_put_non_timed(idx, toroidfieldpath, toroidfield_ext(1))
1084 CALL euitm_put_slice(idx, toroidfieldpath, toroidfield_ext(1))
1086 CALL euitm_put_non_timed(idx, toroidfieldpath, toroidfield(1))
1087 CALL euitm_put_slice(idx, toroidfieldpath, toroidfield(1))
1089 print *,
'==============================================================='
1090 print *,
'>>>>>>>>>>>>>> TOROIDFIELD FINISHED'
1091 print *,
'==============================================================='
1094 IF(external_wall)
THEN
1095 CALL euitm_put_non_timed(idx, wallpath, wall_ext(1))
1096 CALL euitm_put_slice(idx, wallpath, wall_ext(1))
1101 print *,
'==============================================================='
1102 print *,
'>>>>>>>>>>>>>> WALL FINISHED'
1103 print *,
'==============================================================='
1110 WRITE(*,*)
'Data written for ',shot, run
1115 CALL deallocate_cpo(coreprof )
1116 CALL deallocate_cpo(coretransp )
1117 CALL deallocate_cpo(coresource )
1118 CALL deallocate_cpo(coreimpur )
1120 CALL deallocate_cpo(coreneutrals )
1121 CALL deallocate_cpo(compositionc )
1123 CALL deallocate_cpo(equilibrium)
1124 CALL deallocate_cpo(toroidfield)
1131 DEALLOCATE ( intjpar )
1147 REAL(R8) :: x(:),
profile(1:size(x))
1148 CHARACTER (len=BUFLEN) :: function_string
1150 type(equationparser
) :: function_descriptor
1151 character(len=10) :: variables(1) = [
'x']
1155 function_descriptor = equationparser(trim(function_string), variables)
1162 profile(i) = function_descriptor%evaluate([x(i)])
1171 nzimp, ncomp, ntype, &
1175 amn_imp, zn_imp, max_z_imp, &
1189 TYPE (type_param
),
INTENT(in) :: codeparameters
1190 INTEGER(ikind),
INTENT(out) :: return_status
1192 TYPE(tree
) :: parameter_list
1193 TYPE(element
),
POINTER :: temp_pointer
1194 INTEGER(ikind) :: i, nparm, n_values
1195 INTEGER :: n_data1, n_data2, n_data3
1196 CHARACTER(len = 132) :: cname
1197 CHARACTER (len=256),
ALLOCATABLE :: tmp_string(:)
1198 REAL (R8) :: tmp_real(10*100)
1199 INTEGER :: tmp_int(10*100)
1203 INTEGER :: integer_data(1000)
1204 REAL(R8) :: real_data(1000)
1206 LOGICAL :: l_nion=.false., l_nimp=.false., l_nzimp=.false.
1208 INTEGER,
ALLOCATABLE :: nzimp(:)
1209 INTEGER,
ALLOCATABLE :: ncomp(:)
1210 INTEGER,
ALLOCATABLE :: ntype(:)
1213 REAL (R8),
ALLOCATABLE :: amn(:)
1214 REAL (R8),
ALLOCATABLE :: zn(:)
1215 REAL (R8),
ALLOCATABLE :: zion(:)
1216 REAL (R8),
ALLOCATABLE :: amn_imp(:)
1217 REAL (R8),
ALLOCATABLE :: zn_imp(:)
1218 REAL (R8),
ALLOCATABLE :: max_z_imp(:)
1245 WRITE(*,*)
'Calling euitm_xml_parse'
1246 CALL euitm_xml_parse(code_parameters, nparm, parameter_list)
1247 WRITE(*,*)
'Called euitm_xml_parse'
1251 temp_pointer => parameter_list%first
1256 ALLOCATE(ni_f(nion)) ; ni_f =
'0.0'
1257 ALLOCATE(ti_f(nion)) ; ti_f =
'0.0'
1258 ALLOCATE(vtor_f(nion)) ; vtor_f =
'0.0'
1259 ALLOCATE(ni_diff_f(3,nion)) ; ni_diff_f =
'0.0'
1260 ALLOCATE(ni_conv_f(3,nion)) ; ni_conv_f =
'0.0'
1261 ALLOCATE(ti_diff_f(nion)) ; ti_diff_f =
'0.0'
1262 ALLOCATE(ti_conv_f(nion)) ; ti_conv_f =
'0.0'
1263 ALLOCATE(vtor_diff_f(nion)) ; vtor_diff_f =
'0.0'
1264 ALLOCATE(vtor_conv_f(nion)) ; vtor_conv_f =
'0.0'
1265 ALLOCATE(qi_exp_f(nion)) ; qi_exp_f =
'0.0'
1266 ALLOCATE(qi_imp_f(nion)) ; qi_imp_f =
'0.0'
1267 ALLOCATE(si_exp_f(nion)) ; si_exp_f =
'0.0'
1268 ALLOCATE(si_imp_f(nion)) ; si_imp_f =
'0.0'
1269 ALLOCATE(ui_exp_f(nion)) ; ui_exp_f =
'0.0'
1270 ALLOCATE(ui_imp_f(nion)) ; ui_imp_f =
'0.0'
1274 IF(l_nimp.AND.l_nzimp)
THEN
1276 ALLOCATE(imp_nz_f(nzimps)) ; imp_nz_f =
'0.0'
1277 ALLOCATE(imp_diff_f(nzimps)) ; imp_diff_f =
'0.0'
1278 ALLOCATE(imp_conv_f(nzimps)) ; imp_conv_f =
'0.0'
1280 ALLOCATE(qz_exp_f(nzimps)) ; qz_exp_f =
'0.0'
1281 ALLOCATE(qz_imp_f(nzimps)) ; qz_imp_f =
'0.0'
1282 ALLOCATE(sz_exp_f(nzimps)) ; sz_exp_f =
'0.0'
1283 ALLOCATE(sz_imp_f(nzimps)) ; sz_imp_f =
'0.0'
1291 cname = char2str(temp_pointer%cname)
1294 temp_pointer => temp_pointer%child
1299 temp_pointer => temp_pointer%child
1302 IF (
ALLOCATED(temp_pointer%cvalue)) &
1303 CALL char2num(temp_pointer%cvalue, nrho)
1304 WRITE(*,*)
'NRHO = ', nrho
1306 IF (
ALLOCATED(temp_pointer%cvalue)) &
1307 CALL char2num(temp_pointer%cvalue, npsi)
1309 IF (
ALLOCATED(temp_pointer%cvalue)) &
1310 CALL char2num(temp_pointer%cvalue, ndim1)
1312 IF (
ALLOCATED(temp_pointer%cvalue)) &
1313 CALL char2num(temp_pointer%cvalue, ndim2)
1314 CASE (
"neq_max_npoints")
1315 IF (
ALLOCATED(temp_pointer%cvalue)) &
1316 CALL char2num(temp_pointer%cvalue, npoints)
1321 temp_pointer => temp_pointer%child
1324 IF (
ALLOCATED(temp_pointer%cvalue)) &
1325 CALL char2num(temp_pointer%cvalue, shot)
1327 IF (
ALLOCATED(temp_pointer%cvalue)) &
1328 CALL char2num(temp_pointer%cvalue, run)
1334 temp_pointer => temp_pointer%child
1337 IF (
ALLOCATED(temp_pointer%cvalue)) &
1338 CALL char2num(temp_pointer%cvalue, time)
1340 IF (
ALLOCATED(temp_pointer%cvalue)) &
1341 CALL char2num(temp_pointer%cvalue, r0)
1343 IF (
ALLOCATED(temp_pointer%cvalue)) &
1344 CALL char2num(temp_pointer%cvalue, b0)
1346 IF (
ALLOCATED(temp_pointer%cvalue)) &
1347 CALL char2num(temp_pointer%cvalue, a0)
1349 IF (
ALLOCATED(temp_pointer%cvalue)) &
1350 CALL char2num(temp_pointer%cvalue, ip)
1352 IF (
ALLOCATED(temp_pointer%cvalue)) &
1353 CALL char2num(temp_pointer%cvalue, rgeo)
1355 IF (
ALLOCATED(temp_pointer%cvalue)) &
1356 rho_f = char2str(temp_pointer%cvalue)
1361 CASE (
"compositions")
1362 temp_pointer => temp_pointer%child
1366 CASE (
"force_compositions")
1367 IF (
ALLOCATED(temp_pointer%cvalue)) &
1368 CALL char2num(temp_pointer%cvalue, force_compositions)
1372 temp_pointer => temp_pointer%child
1375 IF (
ALLOCATED(temp_pointer%cvalue)) &
1376 CALL scan_str2real(char2str(temp_pointer%cvalue), real_data, n_data1)
1377 ALLOCATE(amn(n_data1))
1378 amn = real_data(1:n_data1)
1381 IF (
ALLOCATED(temp_pointer%cvalue)) &
1382 CALL scan_str2real(char2str(temp_pointer%cvalue), real_data, n_data2)
1383 ALLOCATE(zn(n_data2))
1384 zn = real_data(1:n_data2)
1387 IF (
ALLOCATED(temp_pointer%cvalue)) &
1388 CALL scan_str2real(char2str(temp_pointer%cvalue), real_data, n_data3)
1389 ALLOCATE(zion(n_data3))
1390 zion = real_data(1:n_data3)
1392 nion = min(n_data1, n_data2, n_data3)
1397 temp_pointer => temp_pointer%child
1400 IF (
ALLOCATED(temp_pointer%cvalue))
then
1401 CALL scan_str2real(char2str(temp_pointer%cvalue), real_data, n_data1)
1402 ALLOCATE(amn_imp(n_data1))
1403 amn_imp = real_data(1:n_data1)
1409 IF (
ALLOCATED(temp_pointer%cvalue))
then
1410 CALL scan_str2real(char2str(temp_pointer%cvalue), real_data, n_data2)
1411 ALLOCATE(zn_imp(n_data2))
1412 zn_imp = real_data(1:n_data2)
1418 IF (
ALLOCATED(temp_pointer%cvalue))
then
1419 CALL scan_str2real(char2str(temp_pointer%cvalue), real_data, n_data3)
1420 ALLOCATE(max_z_imp(n_data3))
1421 max_z_imp = real_data(1:n_data3)
1427 nimp = min(n_data1, n_data2, n_data3)
1429 ALLOCATE (nzimp(nimp))
1430 nzimp = nint(max_z_imp)
1437 temp_pointer => temp_pointer%child
1439 CASE (
"cold_neutrals")
1440 IF (
ALLOCATED(temp_pointer%cvalue)) &
1441 CALL char2num(temp_pointer%cvalue, cold_neutrals)
1442 IF (cold_neutrals.gt.0) cold_neutrals = 1
1443 CASE (
"thermal_neutrals")
1444 IF (
ALLOCATED(temp_pointer%cvalue)) &
1445 CALL char2num(temp_pointer%cvalue, thermal_neutrals)
1446 IF (thermal_neutrals.gt.0) thermal_neutrals = 1
1447 CASE (
"fast_neutrals")
1448 IF (
ALLOCATED(temp_pointer%cvalue)) &
1449 CALL char2num(temp_pointer%cvalue, fast_neutrals)
1450 IF (fast_neutrals.gt.0) fast_neutrals = 1
1451 CASE (
"NBI_neutrals")
1452 IF (
ALLOCATED(temp_pointer%cvalue)) &
1453 CALL char2num(temp_pointer%cvalue, nbi_neutrals)
1454 IF (nbi_neutrals.gt.0) nbi_neutrals = 1
1459 if(cold_neutrals + thermal_neutrals + fast_neutrals + nbi_neutrals .gt. 0)
then
1461 ALLOCATE (ncomp(nneut))
1462 ALLOCATE (ntype(nneut))
1464 ntype = cold_neutrals + thermal_neutrals + fast_neutrals + nbi_neutrals
1470 CASE (
"equilibrium")
1471 temp_pointer => temp_pointer%child
1473 CASE (
"equilibrium_ext")
1474 IF (
ALLOCATED(temp_pointer%cvalue))
THEN
1475 equilibrium_external = char2str(temp_pointer%cvalue)
1476 WRITE(*,*)
'<<',trim(equilibrium_external),
'>>'
1477 external_equilibrium = equilibrium_external /=
''
1480 IF (
ALLOCATED(temp_pointer%cvalue)) &
1481 CALL char2num(temp_pointer%cvalue, el)
1483 IF (
ALLOCATED(temp_pointer%cvalue)) &
1484 CALL char2num(temp_pointer%cvalue, tr_u)
1486 IF (
ALLOCATED(temp_pointer%cvalue)) &
1487 CALL char2num(temp_pointer%cvalue, tr_l)
1491 temp_pointer => temp_pointer%child
1493 CASE (
"coreprof_ext")
1494 IF (
ALLOCATED(temp_pointer%cvalue))
THEN
1495 coreprof_external = char2str(temp_pointer%cvalue)
1496 WRITE(*,*)
'<<',trim(coreprof_external),
'>>'
1497 external_coreprof = coreprof_external /=
''
1502 IF(.NOT.external_coreprof)
THEN
1503 IF (
ALLOCATED(temp_pointer%cvalue)) &
1504 CALL scan_str2str(char2str(temp_pointer%cvalue), 256, ni_f, lng)
1508 IF(.NOT.external_coreprof)
THEN
1509 IF (
ALLOCATED(temp_pointer%cvalue)) &
1510 CALL scan_str2str(char2str(temp_pointer%cvalue), 256, ti_f, lng)
1514 IF(.NOT.external_coreprof)
THEN
1515 IF (
ALLOCATED(temp_pointer%cvalue)) &
1516 CALL scan_str2str(char2str(temp_pointer%cvalue), 256, vtor_f, lng)
1519 IF(.NOT.external_coreprof)
THEN
1520 IF (
ALLOCATED(temp_pointer%cvalue)) &
1521 te_f = char2str(temp_pointer%cvalue)
1524 IF(.NOT.external_coreprof)
THEN
1525 IF (
ALLOCATED(temp_pointer%cvalue)) &
1526 jpar_f = char2str(temp_pointer%cvalue)
1529 IF(.NOT.external_coreprof)
THEN
1530 IF (
ALLOCATED(temp_pointer%cvalue)) &
1531 qsf_f = char2str(temp_pointer%cvalue)
1536 temp_pointer => temp_pointer%child
1538 CASE (
"coretransp_ext")
1539 IF (
ALLOCATED(temp_pointer%cvalue))
THEN
1540 coretransp_external = char2str(temp_pointer%cvalue)
1541 WRITE(*,*)
'<<',trim(coretransp_external),
'>>'
1542 external_coretransp = coretransp_external /=
''
1545 IF (
ALLOCATED(temp_pointer%cvalue)) &
1546 sigma_f = char2str(temp_pointer%cvalue)
1549 IF (
ALLOCATED(temp_pointer%cvalue)) &
1550 CALL scan_str2str(char2str(temp_pointer%cvalue), 256, ne_diff_f, lng)
1553 IF (
ALLOCATED(temp_pointer%cvalue)) &
1554 CALL scan_str2str(char2str(temp_pointer%cvalue), 256, ne_conv_f, lng)
1556 ALLOCATE(tmp_string(3*nion)) ; lng =3*nion
1557 IF (
ALLOCATED(temp_pointer%cvalue))
THEN
1558 CALL scan_str2str(char2str(temp_pointer%cvalue), 256, tmp_string, lng)
1559 ni_diff_f=reshape(tmp_string,shape(ni_diff_f))
1561 DEALLOCATE(tmp_string)
1563 ALLOCATE(tmp_string(3*nion)) ; lng =3*nion
1564 IF (
ALLOCATED(temp_pointer%cvalue))
THEN
1565 CALL scan_str2str(char2str(temp_pointer%cvalue), 256, tmp_string, lng)
1566 ni_conv_f=reshape(tmp_string,shape(ni_conv_f))
1568 DEALLOCATE(tmp_string)
1570 IF (
ALLOCATED(temp_pointer%cvalue)) &
1571 te_diff_f = char2str(temp_pointer%cvalue)
1573 IF (
ALLOCATED(temp_pointer%cvalue)) &
1574 te_conv_f = char2str(temp_pointer%cvalue)
1577 IF (
ALLOCATED(temp_pointer%cvalue)) &
1578 CALL scan_str2str(char2str(temp_pointer%cvalue), 256, ti_diff_f, lng)
1581 IF (
ALLOCATED(temp_pointer%cvalue)) &
1582 CALL scan_str2str(char2str(temp_pointer%cvalue), 256, ti_conv_f, lng)
1585 IF (
ALLOCATED(temp_pointer%cvalue)) &
1586 CALL scan_str2str(char2str(temp_pointer%cvalue), 256, vtor_diff_f, lng)
1589 IF (
ALLOCATED(temp_pointer%cvalue)) &
1590 CALL scan_str2str(char2str(temp_pointer%cvalue), 256, vtor_conv_f, lng)
1593 ALLOCATE(tmp_string(nzimps)) ; lng=nzimps
1594 IF (
ALLOCATED(temp_pointer%cvalue))
THEN
1595 CALL scan_str2str(char2str(temp_pointer%cvalue), 256, tmp_string, lng)
1596 imp_diff_f=tmp_string
1598 DEALLOCATE(tmp_string)
1602 ALLOCATE(tmp_string(nzimps)) ; lng=nzimps
1603 IF (
ALLOCATED(temp_pointer%cvalue))
THEN
1604 CALL scan_str2str(char2str(temp_pointer%cvalue), 256, tmp_string, lng)
1605 imp_conv_f=tmp_string
1607 DEALLOCATE(tmp_string)
1612 temp_pointer => temp_pointer%child
1614 CASE (
"coresource_ext")
1615 IF (
ALLOCATED(temp_pointer%cvalue))
THEN
1616 coresource_external = char2str(temp_pointer%cvalue)
1617 WRITE(*,*)
'<<',trim(coresource_external),
'>>'
1618 external_coresource = coresource_external /=
''
1621 IF (
ALLOCATED(temp_pointer%cvalue)) &
1622 j_src_f = char2str(temp_pointer%cvalue)
1624 IF (
ALLOCATED(temp_pointer%cvalue)) &
1625 sigma_src_f = char2str(temp_pointer%cvalue)
1627 IF (
ALLOCATED(temp_pointer%cvalue)) &
1628 qe_exp_f = char2str(temp_pointer%cvalue)
1630 IF (
ALLOCATED(temp_pointer%cvalue)) &
1631 qe_imp_f = char2str(temp_pointer%cvalue)
1633 IF (
ALLOCATED(temp_pointer%cvalue)) &
1634 se_exp_f = char2str(temp_pointer%cvalue)
1636 IF (
ALLOCATED(temp_pointer%cvalue)) &
1637 se_imp_f = char2str(temp_pointer%cvalue)
1640 IF (
ALLOCATED(temp_pointer%cvalue)) &
1641 CALL scan_str2str(char2str(temp_pointer%cvalue), 256, qi_exp_f, lng)
1644 IF (
ALLOCATED(temp_pointer%cvalue)) &
1645 CALL scan_str2str(char2str(temp_pointer%cvalue), 256, qi_imp_f, lng)
1648 ALLOCATE(tmp_string(nzimps)) ; lng=nzimps
1649 IF (
ALLOCATED(temp_pointer%cvalue))
THEN
1650 CALL scan_str2str(char2str(temp_pointer%cvalue), 256, tmp_string, lng)
1653 DEALLOCATE(tmp_string)
1657 ALLOCATE(tmp_string(nzimps)) ; lng=nzimps
1658 IF (
ALLOCATED(temp_pointer%cvalue))
THEN
1659 CALL scan_str2str(char2str(temp_pointer%cvalue), 256, tmp_string, lng)
1662 DEALLOCATE(tmp_string)
1666 IF (
ALLOCATED(temp_pointer%cvalue)) &
1667 CALL scan_str2str(char2str(temp_pointer%cvalue), 256, si_exp_f, lng)
1670 IF (
ALLOCATED(temp_pointer%cvalue)) &
1671 CALL scan_str2str(char2str(temp_pointer%cvalue), 256, si_imp_f, lng)
1674 ALLOCATE(tmp_string(nzimps)) ; lng=nzimps
1675 IF (
ALLOCATED(temp_pointer%cvalue))
THEN
1676 CALL scan_str2str(char2str(temp_pointer%cvalue), 256, tmp_string, lng)
1679 DEALLOCATE(tmp_string)
1683 ALLOCATE(tmp_string(nzimps)) ; lng=nzimps
1684 IF (
ALLOCATED(temp_pointer%cvalue))
THEN
1685 CALL scan_str2str(char2str(temp_pointer%cvalue), 256, tmp_string, lng)
1688 DEALLOCATE(tmp_string)
1692 IF (
ALLOCATED(temp_pointer%cvalue)) &
1693 CALL scan_str2str(char2str(temp_pointer%cvalue), 256, ui_exp_f, lng)
1696 IF (
ALLOCATED(temp_pointer%cvalue)) &
1697 CALL scan_str2str(char2str(temp_pointer%cvalue), 256, ui_imp_f, lng)
1701 temp_pointer => temp_pointer%child
1703 CASE (
"coreimpur_ext")
1704 IF (
ALLOCATED(temp_pointer%cvalue))
THEN
1705 coreimpur_external = char2str(temp_pointer%cvalue)
1706 WRITE(*,*)
'<<',trim(coreimpur_external),
'>>'
1707 external_coreimpur = coreimpur_external /=
''
1711 ALLOCATE(tmp_string(nzimps)) ; lng=nzimps
1712 IF (
ALLOCATED(temp_pointer%cvalue))
THEN
1713 CALL scan_str2str(char2str(temp_pointer%cvalue), 256, tmp_string, lng)
1716 DEALLOCATE(tmp_string)
1721 temp_pointer => temp_pointer%child
1724 IF (
ALLOCATED(temp_pointer%cvalue))
THEN
1725 wall_external = char2str(temp_pointer%cvalue)
1726 WRITE(*,*)
'<<',trim(wall_external),
'>>'
1727 external_wall = wall_external /=
''
1732 WRITE(*, *)
'ERROR: invalid parameter', cname
1737 IF (
ASSOCIATED(temp_pointer%sibling))
THEN
1738 temp_pointer => temp_pointer%sibling
1741 IF (
ASSOCIATED(temp_pointer%parent, parameter_list%first )) &
1743 IF (
ASSOCIATED(temp_pointer%parent))
THEN
1744 temp_pointer => temp_pointer%parent
1746 WRITE(*, *)
'ERROR: broken list.'
1753 CALL destroy_xml_tree(parameter_list)
1760 CHARACTER*(*) EXTERNAL, user, machine, ual_version
1763 INTEGER i1, i2, c, slash
1771 CALL getenv(
'USER', user)
1772 CALL getenv(
'DATAVERSION', ual_version)
1773 IF(ual_version.EQ.
'')
THEN
1774 ual_version =
'4.08b'
1776 CALL getenv(
'TOKAMAKNAME', machine)
1777 IF(machine.EQ.
'')
THEN
1782 i2=len_trim(
EXTERNAL)
1783 slash=index(external(i1:i2),
'/')
1785 DO WHILE (slash.NE.0)
1789 slash=index(external(i1:i2),
'/')
1797 slash=index(external(i1:i2),
'/')
1799 READ(external(i1:i1+slash-2),*) shot
1801 WRITE(*,*)
'shot not specified'
1806 READ(external(i1:i2),*) run
1808 WRITE(*,*)
'run not specified'
1811 ELSE IF(c.EQ.4)
THEN
1813 slash=index(external(i1:i2),
'/')
1815 user = external(i1:i1+slash-2)
1819 slash=index(external(i1:i2),
'/')
1821 machine = external(i1:i1+slash-2)
1825 slash=index(external(i1:i2),
'/')
1827 ual_version = external(i1:i1+slash-2)
1831 slash=index(external(i1:i2),
'/')
1833 READ(external(i1:i1+slash-1),*) shot
1835 WRITE(*,*)
'shot not specified'
1841 READ(external(i1:i2),*) run
1843 WRITE(*,*)
'run not specified'
1847 WRITE(*,*)
'Could not parse ', trim(
EXTERNAL)
1875 REAL (R8) :: x(n), &
1879 intyx(1)=y(1)*x(1)**2/2.e0_r8
1881 intyx(i)=intyx(i-1)+(y(i-1)*x(i-1)+y(i)*x(i))*(x(i)-x(i-1))/2.e0_r8
1906 REAL (R8) :: x(n), &
1912 inty(i)=inty(i-1)+(y(i)+y(i-1))*(x(i)-x(i-1))/2.e0_r8
subroutine assign_code_parameters(codeparameters, return_status)
subroutine euitm_open_env(name, shot, run, retIdx, user, tokamak, version)
subroutine allocate_coreimpur_cpo(NSLICE, NRHO, NNUCL, NION, NIMP, NZIMP, NNEUT, NTYPE, NCOMP, COREIMPUR)
This routine allocates COREIMPUR CPO.
subroutine allocate_coreprof_cpo(NSLICE, NRHO, NNUCL, NION, NIMP, NZIMP, NNEUT, NTYPE, NCOMP, COREPROF)
This routine allocates COREPROF CPO.
subroutine l3interp(y_in, x_in, nr_in, y_out, x_out, nr_out)
This module contains routines for allocation/deallocation if CPOs used in ETS.
subroutine allocate_coresource_cpo(NSLICE, NRHO, NNUCL, NION, NIMP, NZIMP, NNEUT, NTYPE, NCOMP, CORESOURCE)
This routine allocates CORESOURCE CPO.
subroutine allocate_equilibrium_cpo(NSLICE, NPSI, NDIM1, NDIM2, NPOINTS, EQUILIBRIUM)
This routine allocates EQUILIBRIUM CPO.
real(r8) function, dimension(1:size(x)) profile(function_string, x)
subroutine set_plasma_composition(COREPROF_OUT, NION, NIMP, NNEUT, AMN_ION, ZN_ION, Z_ION, AMN_IMP, ZN_IMP, MAXZ_IMP, NCOMP_IN, NTYPE_IN, NCOLD, NTHERMAL, NFAST, NNBI)
subroutine cubint(ntab, xtab, ftab, ia_in, ib_in, result, error)
subroutine allocate_coreneutrals_cpo(NSLICE, NRHO, NNUCL, NION, NIMP, NZIMP, NNEUT, NTYPE, NCOMP, CORENEUTRALS)
subroutine allocate_compositionc_cpo(NSLICE, NNUCL, NION, NIMP, NZIMP, NNEUT, NTYPE, NCOMP, COMPOSITIONC)
subroutine allocate_toroidfield_cpo(NSLICE, TOROIDFIELD)
This routine allocates TOROIDFIELD CPO.
subroutine integral(n, h, r, f, int)
subroutine euitm_close(idx)
subroutine allocate_coretransp_cpo(NSLICE, NRHO, NNUCL, NION, NIMP, NZIMP, NNEUT, NTYPE, NCOMP, CORETRANSP)
This routine allocates CORETRANSP CPO.