48 USE deallocate_structures
75 USE size_of_structures
98 TYPE (type_equilibrium
),
POINTER :: equilibrium_old(:) => null(), equilibrium_iter(:) => null(), equilibrium_new(:) => null()
99 TYPE (type_coreprof
),
POINTER :: coreprof_old(:) => null(), coreprof_iter(:) => null(), coreprof_new(:) => null()
100 TYPE (type_coretransp
),
POINTER :: coretransp_old(:) => null(), coretransp_iter(:) => null()
101 TYPE (type_coresource
),
POINTER :: coresource_old(:) => null(), coresource_iter(:) => null()
102 TYPE (type_coreimpur
),
POINTER :: coreimpur_old(:) => null(), coreimpur_iter(:) => null(), coreimpur_new(:) => null()
103 TYPE (type_corefast
),
POINTER :: corefast_old(:) => null() , corefast_iter(:) => null()
104 TYPE (type_coreneutrals
),
POINTER :: coreneutrals_old(:) => null(),coreneutrals_iter(:) => null(),coreneutrals_new(:) => null()
105 TYPE (type_toroidfield
),
POINTER :: toroidfield_old(:) => null()
106 TYPE (type_neoclassic
),
POINTER :: neoclassic_old(:) => null(), neoclassic_iter(:) => null()
109 TYPE (type_edge
),
POINTER :: edge_new(:)
110 TYPE (type_limiter
) :: limiter
111 TYPE (type_param
) :: code_parameters_core_edge
114 TYPE (type_coreprof
),
SAVE,
POINTER :: coreprof_db(:) => null()
115 TYPE (type_coretransp
),
SAVE,
POINTER :: coretransp_db(:) => null()
116 TYPE (type_coresource
),
SAVE,
POINTER :: coresource_db(:) => null()
117 TYPE (type_coreimpur
),
SAVE,
POINTER :: coreimpur_db(:) => null()
118 TYPE (type_corefast
),
SAVE,
POINTER :: corefast_db(:) => null()
119 TYPE (type_coreneutrals
),
SAVE,
POINTER :: coreneutrals_db(:) => null()
120 TYPE (type_equilibrium
),
SAVE,
POINTER :: equilibrium_db(:) => null()
121 TYPE (type_toroidfield
),
SAVE,
POINTER :: toroidfield_db(:) => null()
122 TYPE (type_neoclassic
),
SAVE,
POINTER :: neoclassic_db(:) => null()
124 TYPE (type_coretransp
),
SAVE,
POINTER :: coretransp1(:) => null(),coretransp2(:) => null(),coretransp3(:) => null(),coretransp4(:) => null(),coretransp5(:) => null()
125 TYPE (type_coresource
),
SAVE,
POINTER :: coresource1(:) => null(),coresource2(:) => null(),coresource3(:) => null(),coresource4(:) => null(),coresource5(:) => null(),coresource6(:) => null(),coresource7(:) => null()
127 TYPE (type_param
) :: code_parameters_ets, code_parameters_transport_combiner, &
128 code_parameters_sources_combiner, code_parameters_ets_workflow, &
129 code_parameters_gausian_sources
138 INTEGER :: max_npoints
139 INTEGER :: neq_max_npoints
145 INTEGER,
ALLOCATABLE,
SAVE :: nzimp(:)
148 INTEGER,
ALLOCATABLE,
SAVE :: ncomp(:)
149 INTEGER,
ALLOCATABLE,
SAVE :: ntype(:)
152 INTEGER,
PARAMETER :: nslice = 1
159 INTEGER :: solver_type
160 INTEGER :: sigma_source
163 REAL(R8) :: conv_neut, conv_imp
165 REAL(R8) :: start_time
170 INTEGER,
PARAMETER :: maxiter=1000
172 REAL (R8),
ALLOCATABLE,
SAVE :: amn(:)
173 REAL (R8),
ALLOCATABLE,
SAVE :: zn(:)
174 REAL (R8),
ALLOCATABLE,
SAVE :: zion(:)
175 REAL (R8),
ALLOCATABLE,
SAVE :: amn_imp(:)
176 REAL (R8),
ALLOCATABLE,
SAVE :: zn_imp(:)
177 REAL (R8),
ALLOCATABLE,
SAVE :: max_z_imp(:)
179 INTEGER :: cold_neutrals
180 INTEGER :: thermal_neutrals
181 INTEGER :: fast_neutrals
182 INTEGER :: nbi_neutrals
184 INTEGER :: psi_bnd_type
185 INTEGER :: te_bnd_type
186 INTEGER :: ne_bnd_type
187 INTEGER,
ALLOCATABLE,
SAVE :: ni_bnd_type(:)
188 INTEGER,
ALLOCATABLE,
SAVE :: ti_bnd_type(:)
189 INTEGER,
ALLOCATABLE,
SAVE :: vtor_bnd_type(:)
190 INTEGER,
ALLOCATABLE,
SAVE :: nimp_bnd_type(:,:)
191 INTEGER,
ALLOCATABLE,
SAVE :: n0_bnd_type(:,:)
192 INTEGER,
ALLOCATABLE,
SAVE :: t0_bnd_type(:,:)
194 REAL (R8) :: psi_bnd_value(3)
195 REAL (R8) :: te_bnd_value(3)
196 REAL (R8) :: ne_bnd_value(3)
197 REAL (R8),
ALLOCATABLE,
SAVE :: ni_bnd_value(:,:)
198 REAL (R8),
ALLOCATABLE,
SAVE :: ti_bnd_value(:,:)
199 REAL (R8),
ALLOCATABLE,
SAVE :: vtor_bnd_value(:,:)
201 REAL (R8),
ALLOCATABLE,
SAVE :: nimp_bnd_value(:,:,:)
203 REAL (R8),
ALLOCATABLE,
SAVE :: n0_bnd_value(:,:,:)
204 REAL (R8),
ALLOCATABLE,
SAVE :: t0_bnd_value(:,:,:)
208 REAL (R8) :: geo_ax(3)
209 REAL (R8) :: plasma_ax(3)
211 REAL (R8) :: elong, elong_up, elong_low
213 REAL (R8) :: tria_low
215 INTEGER :: control_integer(4)
216 REAL (R8) :: control_double(6)
219 REAL (R8) :: control_double_imp(4)
220 INTEGER :: iimp,isimp,simp
223 INTEGER :: shot_in, run_in
225 INTEGER :: time_dep_input
229 INTEGER :: ext_source
230 INTEGER :: ext_transport
231 INTEGER :: shot_out, run_out
238 INTEGER :: exp_option
244 INTEGER :: quasi_neut
248 REAL (R8) :: add_transport
250 REAL (R8) :: time_out
255 INTEGER,
PARAMETER :: buflen = 256
256 CHARACTER(len=BUFLEN) :: rho_f
257 REAL(R8),
ALLOCATABLE :: rho_1(:), rho_2(:), rho_3(:), rho_4(:), rho_5(:)
258 REAL(R8) :: dummy1, dummy2, x
259 REAL (R8),
ALLOCATABLE :: rho(:)
260 REAL (R8) :: r_in, r_out, r_geo
261 REAL (R8) :: rho_tor_rescale
263 REAL (R8) :: bc_ip_jrlx, bc_ip_wanted, bc_ip_current, bc_ip_tau
265 REAL (R8),
POINTER :: evolution_data(:,:) => null()
266 CHARACTER (len=32),
POINTER :: evolution_labels(:) => null()
267 CHARACTER (len=32) :: db_in, db_out
268 INTEGER :: augment_equil
270 INTEGER (ITM_I8) :: total_size = 0
274 CHARACTER (len=256) :: filename
275 LOGICAL,
SAVE :: use_euitm_get, use_euitm_put
280 SUBROUTINE external_transport(EQUILIBRIUM_ITER,COREPROF_ITER,CORETRANSP_ITER,add_transport)
283 TYPE (type_equilibrium
),
POINTER :: equilibrium_iter(:)
284 TYPE (type_coreprof
),
POINTER :: coreprof_iter(:)
285 TYPE (type_coretransp
),
POINTER :: coretransp_iter(:)
286 REAL (R8) :: add_transport
289 SUBROUTINE b2mn_ets(coreprof_in, coreimpur_in, coreneutrals_in, &
290 coreprof_out, coreimpur_out, coreneutrals_out, edge_out, &
294 TYPE (type_coreprof
),
POINTER :: coreprof_in(:), coreprof_out(:)
295 TYPE (type_coreimpur
),
POINTER :: coreimpur_in(:), coreimpur_out(:)
296 TYPE (type_coreneutrals
),
POINTER :: coreneutrals_in(:), coreneutrals_out(:)
297 TYPE (type_edge
),
POINTER :: edge_out(:)
298 TYPE (type_param
) :: codeparam
299 LOGICAL,
OPTIONAL :: end_set
300 END SUBROUTINE b2mn_ets
314 CALL fill_param(code_parameters_ets,
'XML/ets.xml',
'',
'XML/ets.xsd')
315 CALL fill_param(code_parameters_ets_workflow,
'XML/ets_workflow.xml',
'',
'XML/ets_workflow.xsd')
317 CALL fill_param(code_parameters_core_edge,
'XML/core-edge.xml',
'',
'XML/core-edge.xsd')
326 npsi, nrho, neq_dim1, neq_dim2, max_npoints, &
328 nnucl, nion, nimp, nzimp, nneut, ncomp, ntype, &
332 amn, zn, zion, amn_imp, zn_imp, max_z_imp, &
334 cold_neutrals, thermal_neutrals, &
335 fast_neutrals, nbi_neutrals, &
338 ne_bnd_type, ni_bnd_type, &
339 te_bnd_type, ti_bnd_type, &
343 n0_bnd_type, t0_bnd_type, &
346 ne_bnd_value, ni_bnd_value, &
347 te_bnd_value, ti_bnd_value, &
351 n0_bnd_value, t0_bnd_value, &
353 shot_in, run_in, interpol, db_in, &
354 shot_out, run_out, tau_out, db_out, &
355 solver_type, sigma_source, tau, amix, convrec, &
358 ip, geo_ax, plasma_ax, amin, elong, tria_up, tria_low, &
360 prof_flag, j0_flag, q0_flag, eq_source, &
361 time_dep_input, ext_equil, equil_mod, &
362 ext_source, ext_transport, add_transport, quasi_neut, &
363 tau_inc, tau_dec, iter_inc, iter_dec, &
365 exp_option, exp_ncols, &
366 evolution_labels, evolution_data, &
367 augment_equil, rho_f, icoronal, &
368 code_parameters_ets_workflow)
374 WRITE(*,*)
'++++++++++++++++++++++++++++++++++++++++++++++ '
375 WRITE(*,*)
'++++ INPUT FROM XML FILE IS RECEIVED ++++ '
376 WRITE(*,*)
'++++++++++++++++++++++++++++++++++++++++++++++ '
384 time_end = start_time + ntime * tau
392 ALLOCATE (coreprof_db(1))
393 ALLOCATE (coretransp_db(1))
394 ALLOCATE (coresource_db(1))
395 IF(nimp.GT.0)
ALLOCATE (coreimpur_db(1))
396 ALLOCATE (corefast_db(1))
397 IF(nneut.GT.0)
ALLOCATE (coreneutrals_db(1))
398 ALLOCATE (equilibrium_db(1))
399 ALLOCATE (toroidfield_db(1))
400 ALLOCATE (neoclassic_db(1))
407 IF (shot_in.GT.0.AND.run_in.GE.0)
THEN
410 WRITE(*,*)
'Opening mdsplus database for ', shot_in, run_in
411 CALL euitm_open(
'euitm',shot_in, run_in, idx)
412 use_euitm_get = .true.
414 WRITE(*,*)
'Opening hdf5 database for ', shot_in, run_in
415 CALL euitm_open_hdf5(
'euitm',shot_in, run_in, idx)
416 use_euitm_get = .true.
418 use_euitm_get = .false.
420 WRITE(*,*)
'Unexpected database format choice : ',trim(db_in)
421 stop
'Error: unrecognized database format'
425 use_euitm_get = .false.
429 IF(use_euitm_get)
THEN
430 WRITE(*,*)
'reading from the database for time = ', time
431 CALL euitm_get_slice(idx,
'coreprof', coreprof_db(1), time, interpol)
432 CALL euitm_get_slice(idx,
'coretransp', coretransp_db(1), time, interpol)
433 CALL euitm_get_slice(idx,
'coresource', coresource_db(1), time, interpol)
434 IF(nimp.GT.0) CALL euitm_get_slice(idx,
'coreimpur', coreimpur_db(1), time, interpol)
435 CALL euitm_get_slice(idx,
'corefast', corefast_db(1), time, interpol)
436 IF(nneut.GT.0) CALL euitm_get_slice(idx,
'coreneutrals', coreneutrals_db(1), time, interpol)
437 CALL euitm_get_slice(idx,
'equilibrium', equilibrium_db(1), time, interpol)
438 CALL euitm_get_slice(idx,
'toroidfield', toroidfield_db(1), time, interpol)
439 CALL euitm_get_slice(idx,
'neoclassic', neoclassic_db(1), time, interpol)
444 IF(db_in .EQ.
"ascii")
THEN
445 WRITE(filename,
'(a,''_'',I6.6,''_'',I6.6,''_'',I6.6,''.cpo'')')
'coreprof', shot_in, run_in, 0
446 CALL open_read_file(1, trim(filename))
447 CALL read_cpo(coreprof_db(1),
'coreprof')
449 WRITE(filename,
'(a,''_'',I6.6,''_'',I6.6,''_'',I6.6,''.cpo'')')
'coretransp', shot_in, run_in, 0
450 CALL open_read_file(1, trim(filename))
451 CALL read_cpo(coretransp_db(1),
'coretransp')
453 WRITE(filename,
'(a,''_'',I6.6,''_'',I6.6,''_'',I6.6,''.cpo'')')
'coresource', shot_in, run_in, 0
454 CALL open_read_file(1, trim(filename))
455 CALL read_cpo(coresource_db(1),
'coresource')
458 WRITE(filename,
'(a,''_'',I6.6,''_'',I6.6,''_'',I6.6,''.cpo'')')
'coreimpur', shot_in, run_in, 0
459 CALL open_read_file(1, trim(filename))
460 CALL read_cpo(coreimpur_db(1),
'coreimpur')
464 WRITE(filename,
'(a,''_'',I6.6,''_'',I6.6,''_'',I6.6,''.cpo'')')
'coreneutrals', shot_in, run_in, 0
465 CALL open_read_file(1, trim(filename))
466 CALL read_cpo(coreneutrals_db(1),
'coreneutrals')
469 WRITE(filename,
'(a,''_'',I6.6,''_'',I6.6,''_'',I6.6,''.cpo'')')
'equilibrium', shot_in, run_in, 0
470 CALL open_read_file(1, trim(filename))
471 CALL read_cpo(equilibrium_db(1),
'equilibrium')
473 WRITE(filename,
'(a,''_'',I6.6,''_'',I6.6,''_'',I6.6,''.cpo'')')
'toroidfield', shot_in, run_in, 0
474 CALL open_read_file(1, trim(filename))
475 CALL read_cpo(toroidfield_db(1),
'toroidfield')
484 IF(eq_source.eq.1)
THEN
488 IF(.NOT.
ASSOCIATED(equilibrium_old))
ALLOCATE (equilibrium_old(1))
489 IF(.NOT.
ASSOCIATED(equilibrium_new))
ALLOCATE (equilibrium_new(1))
490 equilibrium_old(1)%time = start_time
492 geo_ax, plasma_ax, plasma_ax, &
494 elong_up, elong_low, &
496 npsi, neq_dim1, neq_dim2, max_npoints)
498 CALL deallocate_cpo(equilibrium_old)
501 WRITE(*,*)
'++++++++++++++++++++++++++++++++++++++++++++++ '
502 WRITE(*,*)
'++++ INITIAL RHO_BOUNDARY IS CALCULATED ++++ '
503 WRITE(*,*)
'++++++++++++++++++++++++++++++++++++++++++++++ '
507 call copy_cpo(equilibrium_db, equilibrium_new)
515 WRITE(*,*)
'++++++++++++++++++++++++++++++++++++++++++++++ '
516 WRITE(*,*)
'++++++++++++++++++++++++++++++++++++++++++++++ '
517 WRITE(*,*)
'Input from ',shot_in, run_in
518 WRITE(*,*)
'Output to ', shot_out, run_out
519 WRITE(*,*)
'++++++++++++++++++++++++++++++++++++++++++++++ '
520 WRITE(*,*)
'+++++++++++++ COMPOSITIONS +++++++++++++++++ '
521 WRITE(*,*)
'nrho =',nrho
522 WRITE(*,*)
'npsi =',npsi
523 WRITE(*,*)
'ndim1=',neq_dim1
524 WRITE(*,*)
'ndim2=',neq_dim2
525 WRITE(*,*)
'max_npoints=',max_npoints
526 WRITE(*,*)
'nnucl=',nnucl
527 WRITE(*,*)
'nion= ',nion
528 WRITE(*,*)
'nimp= ',nimp
529 IF(
ALLOCATED(nzimp))
WRITE(*,*)
'nzimp=', nzimp
530 WRITE(*,*)
'nneut=',nneut
531 IF(
ALLOCATED(ncomp))
WRITE(*,*)
'ncomp=',ncomp
532 IF(
ALLOCATED(ntype))
WRITE(*,*)
'ntype=', ntype
533 IF(
ALLOCATED(amn))
WRITE(*,
'(a,(100f8.2))')
'amn= ', amn
534 IF(
ALLOCATED(zn))
WRITE(*,
'(a,(100f8.2))')
'zn= ',zn
535 IF(
ALLOCATED(zion))
WRITE(*,
'(a,(100f8.2))')
'zion= ', zion
536 IF(
ALLOCATED(amn_imp))
WRITE(*,
'(a,(100f8.2))')
'amn_imp= ', amn_imp
537 IF(
ALLOCATED(zn_imp))
WRITE(*,
'(a,(100f8.2))')
'zn_imp= ',zn_imp
538 IF(
ALLOCATED(max_z_imp))
WRITE(*,
'(a,(100f8.2))')
'max_z_imp= ', max_z_imp
539 WRITE(*,*)
'++++++++++++++++++++++++++++++++++++++++++++++ '
540 WRITE(*,*)
'++++++++++ BOUNDARY CONDITIONS +++++++++++++ '
541 WRITE(*,*)
'++++++++++ TYPE VALUE +++++++++++++ '
542 WRITE(*,*)
'PSI =', psi_bnd_type, psi_bnd_value(1)
543 WRITE(*,*)
'NE =', ne_bnd_type, ne_bnd_value(1)
544 WRITE(*,*)
'NI =', ni_bnd_type, ni_bnd_value(1,:)
545 WRITE(*,*)
'TI =', ti_bnd_type, ti_bnd_value(1,:)
546 WRITE(*,*)
'TE =', te_bnd_type, te_bnd_value(1)
547 WRITE(*,*)
'VTOR=', vtor_bnd_type, vtor_bnd_value(1,:)
548 IF(nimp.GT.0)
WRITE(*,*)
'NIMP=', nimp_bnd_type, nimp_bnd_value(:,1,:)
550 WRITE(*,*)
'++++++++++++++++++++++++++++++++++++++++++++++ '
551 WRITE(*,*)
'++++++++++++++++++++++++++++++++++++++++++++++ '
559 IF (ext_transport.EQ.2) &
560 CALL fill_param(code_parameters_transport_combiner, &
561 'XML/transport_combiner.xml',
'',
'XML/transport_combiner.xsd')
563 IF (ext_source.EQ.2) &
564 CALL fill_param(code_parameters_sources_combiner, &
565 'XML/source_combiner.xml',
'',
'XML/source_combiner.xsd')
567 IF (ext_source.EQ.2) &
568 CALL fill_param(code_parameters_gausian_sources, &
569 'XML/source_dummy.xml',
'',
'XML/source_dummy.xsd')
581 amn_imp, zn_imp, max_z_imp, &
583 cold_neutrals, thermal_neutrals,&
584 fast_neutrals, nbi_neutrals)
586 DEALLOCATE(amn, zn, zion)
587 IF(nimp.GT.0)
DEALLOCATE(amn_imp, zn_imp, max_z_imp)
589 ets_species%nnucl = nnucl
590 ets_species%nion = nion
591 ets_species%nimp = nimp
592 IF(
ALLOCATED(nzimp))
THEN
593 ALLOCATE(ets_species%nzimp(
SIZE(nzimp)))
594 ets_species%nzimp = nzimp
596 ets_species%nneut = nneut
597 IF(
ALLOCATED(ncomp))
THEN
598 ALLOCATE(ets_species%ncomp(
SIZE(ncomp)))
599 ets_species%ncomp = ncomp
601 IF(
ALLOCATED(ntype))
THEN
602 ALLOCATE(ets_species%ntype(
SIZE(ntype)))
603 ets_species%ntype = ntype
606 WRITE(*,*)
'++++++++++++++++++++++++++++++++++++++++++++++ '
607 WRITE(*,*)
'+++++++ COMPOSITIONS ARE SET UP +++++++++ '
608 WRITE(*,*)
'++++++++++++++++++++++++++++++++++++++++++++++ '
616 control_integer(1) = solver_type
617 control_integer(2) = sigma_source
618 control_integer(3) = quasi_neut
619 control_double(1) = tau
620 control_double(2) = amix
621 control_double(3) = amix**0.5
622 control_double(4) = 1.e0_r8
623 control_double(5) = convrec
625 control_double_imp(1) = 3.
626 control_double_imp(2) = 1.
627 control_double_imp(3) = tau
628 control_double_imp(4) = amix
643 (solver_type, equilibrium_new, coreprof_new, &
645 coreprof_old, coretransp_old, coresource_old, &
646 coreimpur_old, corefast_old, &
647 coreneutrals_old, neoclassic_old, &
648 equilibrium_old, toroidfield_old, &
650 psi_bnd_type, ne_bnd_type, ni_bnd_type, &
651 ti_bnd_type, te_bnd_type, vtor_bnd_type, &
652 nimp_bnd_type, n0_bnd_type, t0_bnd_type, &
654 psi_bnd_value, ne_bnd_value, ni_bnd_value, &
655 ti_bnd_value, te_bnd_value, vtor_bnd_value, &
656 nimp_bnd_value, n0_bnd_value, t0_bnd_value, &
658 nrho, npsi, neq_dim1, neq_dim2, max_npoints)
660 CALL deallocate_cpo(equilibrium_new)
661 CALL deallocate_cpo(neoclassic_old)
663 CALL copy_cpo(coreprof_old, coreprof_iter)
664 CALL copy_cpo(equilibrium_old, equilibrium_new)
665 CALL copy_cpo(coretransp_old, coretransp_iter)
666 CALL copy_cpo(corefast_old, corefast_iter)
667 CALL copy_cpo(coresource_old, coresource_iter)
669 CALL copy_cpo(coreimpur_old, coreimpur_iter)
670 CALL copy_cpo(coreimpur_old, coreimpur_new)
673 CALL copy_cpo(coreneutrals_old, coreneutrals_iter)
674 CALL copy_cpo(coreneutrals_old, coreneutrals_new)
678 WRITE(*,*)
'++++++++++++++++++++++++++++++++++++++++++++++ '
679 WRITE(*,*)
'+++++++ WORKING CPOs ARE ALLOCATED +++++++++ '
680 WRITE(*,*)
'++++++++++++++++++++++++++++++++++++++++++++++ '
683 WRITE(*,*)
'++++++++++++++++++++++++++++++++++++++++++++++ '
684 WRITE(*,*)
'+++++++ GRIDS ARE SET UP +++++++++ '
685 WRITE(*,*)
'++++++++++++++++++++++++++++++++++++++++++++++ '
697 time_end = start_time + ntime * tau
705 ALLOCATE (coreprof_old(1)%codeparam%codename(1))
706 ALLOCATE (coreprof_old(1)%codeparam%codeversion(1))
707 ALLOCATE (coreprof_old(1)%codeparam%parameters(
SIZE(code_parameters_ets_workflow%parameters)))
709 coreprof_old(1)%codeparam%codename(1) =
'ets_workflow_fortran'
710 coreprof_old(1)%codeparam%codeversion(1) = version
711 coreprof_old(1)%codeparam%parameters = code_parameters_ets_workflow%parameters
713 CALL deallocate_cpo(coreprof_iter(1)%codeparam)
714 CALL copy_cpo(coreprof_old(1)%codeparam, coreprof_iter(1)%codeparam)
716 CALL deallocate_cpo(coreprof_iter)
717 CALL deallocate_cpo(coretransp_iter)
718 CALL deallocate_cpo(coresource_iter)
719 CALL deallocate_cpo(corefast_iter)
722 WRITE(*,*)
'++++++++++++++++++++++++++++++++++++++++++++++ '
723 CALL
fillcorefast(corefast_db, corefast_old, corefast_iter, interpol)
724 WRITE(*,*)
'+++++++ COREFAST IS RECEIVED +++++++++ '
725 CALL
fillcoreprof(coreprof_db, coreprof_old, corefast_iter, coreprof_iter, interpol)
726 WRITE(*,*)
'+++++++ COREPROF IS RECEIVED +++++++++ '
727 CALL
fillcoretransp(coretransp_db, coretransp_old, coretransp_iter, interpol)
728 WRITE(*,*)
'+++++++ CORETRANSP IS RECEIVED +++++++++ '
729 CALL
fillcoresource(coresource_db, coresource_old, coresource_iter, interpol)
730 WRITE(*,*)
'+++++++ CORESOURCE IS RECEIVED +++++++++ '
732 CALL deallocate_cpo(coreimpur_iter)
733 CALL
fillcoreimpur(coreimpur_db, coreimpur_old, coreimpur_iter, interpol)
734 WRITE(*,*)
'+++++++ COREIMPUR IS RECEIVED +++++++++ '
737 CALL deallocate_cpo(coreneutrals_iter)
738 CALL
fillcoreneutrals(coreneutrals_db, coreneutrals_old, coreneutrals_iter, interpol)
739 WRITE(*,*)
'+++++++ CORENEUTRALS IS RECEIVED +++++++++ '
741 CALL deallocate_cpo(equilibrium_iter)
743 CALL
fillequilibrium(equilibrium_db, equilibrium_old, equilibrium_iter, interpol)
750 coreprof_iter%toroid_field%b0 = equilibrium_iter%global_param%toroid_field%b0
751 coreprof_iter%toroid_field%r0 = equilibrium_iter%global_param%toroid_field%r0
753 WRITE(*,*)
'+++++++ EQUILIBRIUM IS RECEIVED +++++++++ '
754 WRITE(*,*)
'++++++++++++++++++++++++++++++++++++++++++++++ '
759 CALL deallocate_cpo(equilibrium_old)
760 CALL copy_cpo(equilibrium_iter, equilibrium_old)
761 CALL deallocate_cpo(coreprof_old)
762 CALL copy_cpo(coreprof_iter, coreprof_old)
763 CALL deallocate_cpo(coretransp_old)
765 CALL deallocate_cpo(coresource_old)
768 CALL deallocate_cpo(coreimpur_old)
769 IF(icoronal.GT.0)
THEN
770 WRITE(*,*)
'Calling set_coronal with option ', icoronal
771 CALL
set_coronal(coreimpur_iter, coreprof_iter, coreimpur_old, interpol, icoronal)
772 CALL deallocate_cpo(coreimpur_iter)
773 CALL copy_cpo(coreimpur_old, coreimpur_iter)
775 CALL copy_cpo(coreimpur_iter, coreimpur_old)
778 CALL deallocate_cpo(corefast_old)
779 CALL copy_cpo(corefast_iter, corefast_old)
780 IF(nneut .GT. 0)
THEN
781 CALL deallocate_cpo(coreneutrals_old)
782 CALL copy_cpo(coreneutrals_iter, coreneutrals_old)
786 WRITE(*,*)
'++++++++++++++++++++++++++++++++++++++++++++++ '
787 WRITE(*,*)
'+++++++ CPOs INPUT DATA ARE READ +++++++++ '
788 WRITE(*,*)
'++++++++++++++++++++++++++++++++++++++++++++++ '
806 IF(prof_flag.GT.0)
THEN
812 (prof_flag, j0_flag, q0_flag, ext_equil, &
813 coreprof_old, equilibrium_old, toroidfield_old, coreprof_iter, equilibrium_iter)
814 CALL deallocate_cpo(equilibrium_old)
815 CALL copy_cpo(equilibrium_iter, equilibrium_old)
817 IF(exp_option.NE.0)
THEN
818 ALLOCATE (neoclassic_iter(1))
826 CALL deallocate_cpo(neoclassic_iter)
828 CALL deallocate_cpo(equilibrium_old)
829 CALL
equil_input(coreprof_iter, toroidfield_old, equilibrium_iter, equilibrium_old)
831 IF (ext_equil.EQ.1)
THEN
832 CALL deallocate_cpo(equilibrium_iter)
835 ELSE IF (ext_equil.EQ.2)
THEN
836 CALL deallocate_cpo(equilibrium_iter)
839 ELSE IF (ext_equil.EQ.3)
THEN
841 CALL deallocate_cpo(equilibrium_iter)
844 WRITE(*,*)
'No HELENA available at compile time'
847 ELSE IF (ext_equil.EQ.4)
THEN
849 CALL deallocate_cpo(equilibrium_iter)
852 WRITE(*,*)
'No CHEASE available at compile time'
861 IF(exp_option.NE.0)
THEN
862 ALLOCATE (neoclassic_iter(1))
870 CALL deallocate_cpo(neoclassic_iter)
872 CALL deallocate_cpo(equilibrium_old)
873 CALL copy_cpo(equilibrium_iter, equilibrium_old)
877 CALL deallocate_cpo(coreprof_old)
878 CALL copy_cpo(coreprof_iter, coreprof_old)
882 CALL deallocate_cpo(coreimpur_old)
883 CALL copy_cpo(coreimpur_iter,coreimpur_old)
884 CALL deallocate_cpo(coreimpur_new)
885 CALL copy_cpo(coreimpur_iter,coreimpur_new)
900 time_out = time_out+tau_out
910 IF (shot_out.GT.0.AND.run_out.GE.0)
THEN
913 CALL euitm_create(
'euitm',shot_out, run_out,0,0,idx)
914 use_euitm_put = .true.
916 CALL euitm_create_hdf5(
'euitm',shot_out,run_out,0,0,idx)
917 use_euitm_put = .true.
919 use_euitm_put = .false.
921 WRITE(*,*)
'Unexpected database format choice : ',trim(db_out)
922 stop
'Error: unrecognized database format'
926 use_euitm_put = .false.
933 IF (shot_out.GT.0.AND.run_out.GE.0)
THEN
935 IF(augment_equil.EQ.1)
THEN
940 IF(use_euitm_put)
THEN
942 coreprof_iter(1)%time = time
943 WRITE(*,*)
'euitm_put_non_timed: coreprof', coreprof_iter(1)%time, &
944 trim(coreprof_iter(1)%codeparam%codename(1)), &
946 trim(coreprof_iter(1)%codeparam%codeversion(1))
947 CALL euitm_put_non_timed(idx,
"coreprof",coreprof_iter(1))
948 WRITE(*,*)
'euitm_put_slice: coreprof', coreprof_iter(1)%time
949 CALL euitm_put_slice(idx,
"coreprof",coreprof_iter(1))
951 equilibrium_iter(1)%time = time
952 WRITE(*,*)
'euitm_put_non_timed: equilibrium', equilibrium_iter(1)%time
953 CALL euitm_put_non_timed(idx,
"equilibrium",equilibrium_iter(1))
954 WRITE(*,*)
'euitm_put_slice: equilibrium', equilibrium_iter(1)%time
955 CALL euitm_put_slice(idx,
"equilibrium",equilibrium_iter(1))
957 coretransp_iter(1)%time = time
958 WRITE(*,*)
'euitm_put_non_timed: coretransp', coretransp_iter(1)%time
959 CALL euitm_put_non_timed(idx,
"coretransp",coretransp_iter(1))
960 WRITE(*,*)
'euitm_put_slice: coretransp', coretransp_iter(1)%time
961 CALL euitm_put_slice(idx,
"coretransp",coretransp_iter(1))
963 coresource_iter(1)%time = time
964 WRITE(*,*)
'euitm_put_non_timed: coresource', coresource_iter(1)%time
965 CALL euitm_put_non_timed(idx,
"coresource",coresource_iter(1))
966 WRITE(*,*)
'euitm_put_slice: coresource', coresource_iter(1)%time
967 CALL euitm_put_slice(idx,
"coresource",coresource_iter(1))
970 coreimpur_iter(1)%time = time
971 WRITE(*,*)
'euitm_put_non_timed: coreimpur', coreimpur_iter(1)%time
972 CALL euitm_put_non_timed(idx,
"coreimpur",coreimpur_iter(1))
973 WRITE(*,*)
'euitm_put_slice: coreimpur', coreimpur_iter(1)%time
974 CALL euitm_put_slice(idx,
"coreimpur",coreimpur_iter(1))
977 coreneutrals_iter(1)%time = time
978 WRITE(*,*)
'euitm_put_non_timed: coreneutrals', coreneutrals_iter(1)%time
979 CALL euitm_put_non_timed(idx,
"coreneutrals",coreneutrals_iter(1))
980 WRITE(*,*)
'euitm_put_slice: coreneutrals', coreneutrals_iter(1)%time
981 CALL euitm_put_slice(idx,
"coreneutrals",coreneutrals_iter(1))
983 toroidfield_old(1)%time = time
984 WRITE(*,*)
'euitm_put_non_timed: toroidfield', toroidfield_old(1)%time
985 CALL euitm_put_non_timed(idx,
"toroidfield",toroidfield_old(1))
986 WRITE(*,*)
'euitm_put_slice: toroidfield', toroidfield_old(1)%time
987 CALL euitm_put_slice(idx,
"toroidfield",toroidfield_old(1))
992 IF(db_out .EQ.
"ascii")
THEN
993 coreprof_iter(1)%time = time
994 WRITE(filename,
'(a,''_'',I6.6,''_'',I6.6,''_'',I6.6,''.cpo'')')
'coreprof', shot_out, run_out, itime
995 CALL open_write_file(1, trim(filename))
996 CALL write_cpo(coreprof_iter(1),
'coreprof')
997 CALL close_write_file
998 equilibrium_iter(1)%time = time
999 WRITE(filename,
'(a,''_'',I6.6,''_'',I6.6,''_'',I6.6,''.cpo'')')
'equilibrium', shot_out, run_out, itime
1000 CALL open_write_file(1, trim(filename))
1001 CALL write_cpo(equilibrium_iter(1),
'equilibrium')
1002 CALL close_write_file
1003 coretransp_iter(1)%time = time
1004 WRITE(filename,
'(a,''_'',I6.6,''_'',I6.6,''_'',I6.6,''.cpo'')')
'coretransp', shot_out, run_out, itime
1005 CALL open_write_file(1, trim(filename))
1006 CALL write_cpo(coretransp_iter(1),
'coretransp')
1007 CALL close_write_file
1008 coresource_iter(1)%time = time
1009 WRITE(filename,
'(a,''_'',I6.6,''_'',I6.6,''_'',I6.6,''.cpo'')')
'coresource', shot_out, run_out, itime
1010 CALL open_write_file(1, trim(filename))
1011 CALL write_cpo(coresource_iter(1),
'coresource')
1012 CALL close_write_file
1014 coreimpur_iter(1)%time = time
1015 WRITE(filename,
'(a,''_'',I6.6,''_'',I6.6,''_'',I6.6,''.cpo'')')
'coreimpur', shot_out, run_out, itime
1016 CALL open_write_file(1, trim(filename))
1017 CALL write_cpo(coreimpur_iter(1),
'coreimpur')
1018 CALL close_write_file
1021 coreneutrals_iter(1)%time = time
1022 WRITE(filename,
'(a,''_'',I6.6,''_'',I6.6,''_'',I6.6,''.cpo'')')
'coreneutrals', shot_out, run_out, itime
1023 CALL open_write_file(1, trim(filename))
1024 CALL write_cpo(coreneutrals_iter(1),
'coreneutrals')
1025 CALL close_write_file
1027 toroidfield_old(1)%time = time
1028 WRITE(filename,
'(a,''_'',I6.6,''_'',I6.6,''_'',I6.6,''.cpo'')')
'toroidfield', shot_out, run_out, itime
1029 CALL open_write_file(1, trim(filename))
1030 CALL write_cpo(toroidfield_old(1),
'toroidfield')
1031 CALL close_write_file
1034 WRITE(*,1000)
' AREA ',equilibrium_iter(1)%global_param%area
1035 WRITE(*,1000)
' VOLUME ',equilibrium_iter(1)%global_param%volume
1036 WRITE(*,1000)
' Raxis ',equilibrium_iter(1)%global_param%mag_axis%position%r
1037 WRITE(*,1000)
' Zaxis ',equilibrium_iter(1)%global_param%mag_axis%position%z
1038 WRITE(*,1000)
' Baxis ',equilibrium_iter(1)%global_param%mag_axis%bphi
1039 WRITE(*,1000)
' Rgeo ',equilibrium_iter(1)%eqgeometry%geom_axis%r
1040 WRITE(*,1000)
' Zgeo ',equilibrium_iter(1)%eqgeometry%geom_axis%z
1041 WRITE(*,1000)
' a ',equilibrium_iter(1)%eqgeometry%a_minor
1042 WRITE(*,1000)
' R0 ',equilibrium_iter(1)%global_param%toroid_field%b0
1043 WRITE(*,1000)
' B0 ',equilibrium_iter(1)%global_param%toroid_field%r0
1046 WRITE(*,*)
'++++++++++++++++++++++++++++++++++++++++++++++ '
1047 WRITE(*,*)
'+++++++ INITIAL SLICE IS SAVED +++++++++ '
1048 WRITE(*,*)
'++++++++++++++++++++++++++++++++++++++++++++++ '
1059 CALL euitm_open(
'euitm',shot_in,0,idx2)
1060 CALL euitm_get(idx2,
'limiter',limiter)
1061 IF(use_euitm_put)
THEN
1062 CALL euitm_put(idx,
'limiter',limiter)
1063 ELSE IF(db_out .EQ.
'ascii')
THEN
1064 WRITE(filename,
'(a,''_'',I6.6,''_'',I6.6,''.cpo'')')
'limiter', shot_out, run_out
1065 CALL open_write_file(1, trim(filename))
1066 CALL write_cpo(limiter,
'limiter')
1067 CALL close_write_file
1070 CALL deallocate_cpo(limiter)
1072 WRITE(*,*)
'Core-Edge: Initialization call to SOLPS'
1073 CALL b2mn_ets(coreprof_iter, coreimpur_iter, coreneutrals_iter, &
1074 coreprof_new, coreimpur_new, coreneutrals_new, edge_new, &
1075 code_parameters_core_edge)
1077 IF(use_euitm_put)
THEN
1078 edge_new(1)%time = time
1079 WRITE(*,*)
'euitm_put_non_timed: edge', edge_new(1)%time
1080 CALL euitm_put_non_timed(idx,
"edge",edge_new(1))
1081 WRITE(*,*)
'euitm_put_slice: edge', edge_new(1)%time
1082 CALL euitm_put_slice(idx,
"edge",edge_new(1))
1085 IF(db_out .EQ.
'ascii')
THEN
1086 edge_new(1)%time = time
1087 WRITE(filename,
'(a,''_'',I6.6,''_'',I6.6,''_'',I6.6,''.cpo'')')
'edge', shot_out, run_out, itime
1088 CALL open_write_file(1, trim(filename))
1089 CALL write_cpo(edge_new(1),
'edge')
1090 CALL close_write_file
1092 CALL deallocate_cpo(coreprof_new)
1093 IF(nimp.GT.0) CALL deallocate_cpo(coreimpur_new)
1094 IF(nneut.GT.0) CALL deallocate_cpo(coreneutrals_new)
1095 CALL deallocate_cpo(edge_new)
1100 IF (psi_bnd_type .EQ. 2)
THEN
1101 bc_ip_tau = 1.0e-3_r8
1102 bc_ip_wanted = psi_bnd_value(1)
1104 - equilibrium_iter(1)%profiles_1d%dpsidrho_tor(npsi) &
1105 * equilibrium_iter(1)%profiles_1d%vprime(npsi) &
1106 * equilibrium_iter(1)%profiles_1d%dpsidrho_tor(npsi) &
1107 * equilibrium_iter(1)%profiles_1d%gm2(npsi) &
1108 / 4.e0_r8 / itm_pi**2 / itm_mu0
1109 WRITE(*,*)
' bc_ip_wanted = ', bc_ip_wanted
1110 WRITE(*,*)
'bc_ip_current = ', bc_ip_current
1111 WRITE(*,*)
' bc_ip_tau = ', bc_ip_tau
1121 time_loop:
DO WHILE(time + tau*0.1_r8 .LT. time_end)
1124 IF(equil_mod.GT.0)
THEN
1125 do_equil=mod(itime,equil_mod).EQ.0
1136 WRITE(*,*)
'!=============================================!'
1137 WRITE(*,*)
'!=============================================!'
1138 WRITE (6,*)
'! TIME=',time
1139 WRITE(*,*)
'!=============================================!'
1140 WRITE(*,*)
'!=============================================!'
1155 WRITE(*,*)
'!=============================================!'
1156 WRITE (6,*)
'! iteration=',iter
1157 WRITE(*,*)
'!=============================================!'
1161 IF(iter.GT.maxiter)
THEN
1162 WRITE(*,
'(a,i0,a)')
'Maximum number of iterations ( ',maxiter,
' ) exceeded'
1163 WRITE(*,
'(a,1pg10.3,a,i0)')
'Time = ', time,
' Number of time iterations = ', itime
1173 WRITE(*,*)
'!---------------------------------------------!'
1174 WRITE (6,*)
'! EQUILIBRIUM !'
1175 WRITE(*,*)
'!---------------------------------------------!'
1177 WRITE(*,*)
'========>> START'
1179 CALL deallocate_cpo(equilibrium_new)
1180 CALL
equil_input(coreprof_iter, toroidfield_old, equilibrium_iter, equilibrium_new)
1190 CALL deallocate_cpo(equilibrium_iter)
1198 IF(ext_equil.EQ.1)
THEN
1199 CALL deallocate_cpo(equilibrium_iter)
1201 ELSEIF(ext_equil.EQ.2)
THEN
1202 CALL deallocate_cpo(equilibrium_iter)
1204 ELSEIF(ext_equil.EQ.3)
THEN
1206 CALL deallocate_cpo(equilibrium_iter)
1209 WRITE(*,*)
'No HELENA available at compile time'
1212 ELSEIF(ext_equil.EQ.4)
THEN
1214 CALL deallocate_cpo(equilibrium_iter)
1217 WRITE(*,*)
'No CHEASE available at compile time'
1220 ELSEIF(ext_equil.EQ.0)
THEN
1221 CALL deallocate_cpo(equilibrium_iter)
1222 CALL copy_cpo(equilibrium_new, equilibrium_iter)
1224 WRITE(*,*)
'Unknown equilibrium option ', ext_equil
1225 stop
'Unknown EQUILIBRIUM'
1229 WRITE(*,*)
'Re-using equilibrium'
1230 CALL deallocate_cpo(equilibrium_iter)
1231 CALL copy_cpo(equilibrium_new, equilibrium_iter)
1234 IF(exp_option.NE.0)
THEN
1235 IF(.NOT.
ASSOCIATED(neoclassic_iter)) &
1236 ALLOCATE (neoclassic_iter(1))
1242 coreneutrals_iter, &
1244 CALL deallocate_cpo(neoclassic_iter)
1247 IF(time_dep_input.EQ.1)
THEN
1249 CALL deallocate_cpo(equilibrium_iter)
1250 CALL copy_cpo(equilibrium_new, equilibrium_iter)
1254 CALL deallocate_cpo(equilibrium_new)
1255 CALL copy_cpo(equilibrium_iter, equilibrium_new)
1283 WRITE(*,*)
'END <<========'
1287 WRITE(*,*)
'!---------------------------------------------!'
1288 WRITE (6,*)
'! TRANSPORT !'
1289 WRITE(*,*)
'!---------------------------------------------!'
1291 WRITE(*,*)
'========>> START'
1293 IF(ext_transport.EQ.1)
THEN
1294 CALL
external_transport(equilibrium_iter, coreprof_iter, coretransp_iter, add_transport)
1297 ELSEIF(ext_transport.EQ.2)
THEN
1300 WRITE(*,*)
'==>> calling DATABASE TRANSPORT'
1301 CALL copy_cpo(coretransp_db, coretransp1)
1305 WRITE(*,*)
'==>> calling NEOCLASSICAL TRANSPORT'
1306 CALL
neowes_wrapper(equilibrium_iter, coreprof_iter, neoclassic_iter)
1311 WRITE(*,*)
'==>> calling ANOMALOUS TRANSPORT'
1312 CALL
gb_transport(equilibrium_iter, coreprof_iter, coretransp3)
1316 WRITE(*,*)
'==>> calling BACKGROUND TRANSPORT'
1318 CALL copy_cpo(coreprof_iter(1)%rho_tor, coretransp4(1)%VALUES(1)%rho_tor)
1319 CALL copy_cpo(coreprof_iter(1)%compositions, coretransp4(1)%compositions)
1323 WRITE(*,*)
'==>> calling SPITZER RESISTIVITY'
1328 IF(
ASSOCIATED(coretransp_old)) stop
'associated(CORETRANSP_OLD) 1'
1329 CALL copy_cpo(coretransp_iter, coretransp_old)
1330 CALL deallocate_cpo(coretransp_iter)
1335 WRITE(*,*)
'==>> calling TRANSPORT COMBINER'
1337 coretransp1, coretransp2, coretransp3, coretransp4, coretransp5, &
1339 1._r8, code_parameters_transport_combiner)
1343 CALL deallocate_cpo(coretransp_old)
1344 CALL deallocate_cpo(coretransp1)
1345 CALL deallocate_cpo(coretransp2)
1346 CALL deallocate_cpo(coretransp3)
1347 CALL deallocate_cpo(coretransp4)
1348 CALL deallocate_cpo(coretransp5)
1353 IF(time_dep_input.EQ.1)
THEN
1354 CALL deallocate_cpo(coretransp_old)
1355 CALL copy_cpo(coretransp_iter, coretransp_old)
1356 CALL deallocate_cpo(coretransp_old)
1364 WRITE(*,*)
'END <<========'
1370 WRITE(*,*)
'!---------------------------------------------!'
1371 WRITE (6,*)
'! SOURCES !'
1372 WRITE(*,*)
'!---------------------------------------------!'
1374 WRITE(*,*)
'========>> START'
1376 IF(ext_source.EQ.2)
THEN
1380 WRITE(*,*)
'==>> calling DATABASE SOURCE'
1381 CALL copy_cpo(coresource_db, coresource1)
1386 WRITE(*,*)
'==>> calling GAUSSIAN SOURCES'
1387 CALL
gausian_sources(coreprof_iter, equilibrium_iter, coresource2, code_parameters_gausian_sources)
1392 WRITE(*,*)
'==>> calling SYNCHROTRON RADIATION'
1398 WRITE(*,*)
'==>> calling HCD SOURCES'
1400 (nslice, nrho, nnucl, nion, nimp, nzimp, nneut, ntype, ncomp, coresource4)
1401 CALL deallocate_cpo(coresource4(1)%VALUES(1)%rho_tor)
1402 CALL copy_cpo(coresource_iter(1)%VALUES(1)%rho_tor, coresource4(1)%VALUES(1)%rho_tor)
1403 CALL deallocate_cpo(coresource4(1)%compositions)
1404 CALL copy_cpo(coresource_iter(1)%compositions, coresource4(1)%compositions)
1409 WRITE(*,*)
'==>> calling NEUTRALS'
1410 IF(
ASSOCIATED(coreneutrals_new))
THEN
1411 CALL deallocate_cpo(coreneutrals_new)
1415 IF(nneut .GT. 0)
THEN
1416 CALL
neutrals_ets(coreimpur_iter, equilibrium_iter, coreprof_iter, &
1417 coreneutrals_old, coreneutrals_iter, &
1418 coresource5, coreneutrals_new, &
1419 control_integer, control_double)
1423 (nslice, nrho, nnucl, nion, nimp, nzimp, nneut, ntype, ncomp, coresource5)
1424 CALL deallocate_cpo(coresource5(1)%VALUES(1)%rho_tor)
1425 CALL copy_cpo(coresource_iter(1)%VALUES(1)%rho_tor, coresource5(1)%VALUES(1)%rho_tor)
1426 CALL deallocate_cpo(coresource5(1)%compositions)
1427 CALL copy_cpo(coresource_iter(1)%compositions, coresource5(1)%compositions)
1433 WRITE(*,*)
'==>> calling IMPURITY'
1434 IF(
ASSOCIATED(coreimpur_new))
THEN
1435 CALL deallocate_cpo(coreimpur_new)
1439 coretransp_iter(1)%VALUES(1)%nz_transp(1)%diff_eff = 1.0_r8
1441 IF(nimp .GT. 0)
THEN
1442 CALL
impurity_ets(equilibrium_iter, coreprof_iter, coretransp_iter, &
1443 coreimpur_old, coreimpur_iter, coreneutrals_iter, &
1444 coresource5, coresource6, coreimpur_new, &
1445 control_integer, control_double)
1449 (nslice, nrho, nnucl, nion, nimp, nzimp, nneut, ntype, ncomp, coresource6)
1450 CALL deallocate_cpo(coresource6(1)%VALUES(1)%rho_tor)
1451 CALL copy_cpo(coresource_iter(1)%VALUES(1)%rho_tor, coresource6(1)%VALUES(1)%rho_tor)
1452 CALL deallocate_cpo(coresource6(1)%compositions)
1453 CALL copy_cpo(coresource_iter(1)%compositions, coresource6(1)%compositions)
1460 WRITE(*,*)
'==>> calling NEOCLASSICAL'
1468 WRITE(*,*)
'==>> calling SOURCE COMBINER'
1469 CALL copy_cpo(coresource_iter, coresource_old)
1470 CALL deallocate_cpo(coresource_iter)
1473 coresource1, coresource2, coresource3, &
1474 coresource4, coresource5, coresource6, &
1476 coresource_iter,1._r8, code_parameters_sources_combiner)
1478 CALL deallocate_cpo(coresource_old)
1479 CALL deallocate_cpo(coresource1)
1480 CALL deallocate_cpo(coresource2)
1481 CALL deallocate_cpo(coresource3)
1482 CALL deallocate_cpo(coresource4)
1483 CALL deallocate_cpo(coresource5)
1484 CALL deallocate_cpo(coresource6)
1485 CALL deallocate_cpo(coresource7)
1488 IF(time_dep_input.EQ.1)
THEN
1489 CALL deallocate_cpo(coresource_old)
1490 CALL copy_cpo(coresource_iter, coresource_old)
1491 CALL deallocate_cpo(coresource_old)
1500 IF(
ASSOCIATED(neoclassic_iter)) CALL deallocate_cpo(neoclassic_iter)
1504 WRITE(*,*)
'END <<========'
1513 WRITE(*,*)
'!---------------------------------------------!'
1514 WRITE(*,*)
'! TRANSPORT EQUATIONS !'
1515 WRITE(*,*)
'!---------------------------------------------!'
1517 WRITE(*,*)
'========>> START'
1526 IF(
ASSOCIATED(coreprof_new)) CALL deallocate_cpo(coreprof_new)
1532 IF(
ASSOCIATED(coreprof_new))
THEN
1533 CALL deallocate_cpo(coreprof_new)
1534 WRITE(*,*)
'Deallocated COREPROF_NEW just before call to ITM_ETS'
1538 CALL
itm_ets(coreprof_old, coreprof_iter, coreprof_new, &
1539 equilibrium_old, equilibrium_iter, &
1540 coretransp_iter, coresource_iter, coreimpur_new, &
1541 control_integer, control_double, code_parameters_ets)
1544 WRITE(*,*)
'END <<========'
1555 CALL deallocate_cpo(coreprof_iter)
1556 CALL copy_cpo(coreprof_new, coreprof_iter)
1557 CALL deallocate_cpo(coreprof_new )
1560 CALL deallocate_cpo(coreimpur_iter)
1561 CALL copy_cpo(coreimpur_new, coreimpur_iter)
1562 CALL deallocate_cpo(coreimpur_new )
1566 CALL deallocate_cpo(coreneutrals_iter)
1567 CALL copy_cpo(coreneutrals_new, coreneutrals_iter)
1570 WRITE(*,
'(a,i3,a,e10.3)')
'CONVERGENCE at iteration=',iter,
': ',control_double(4)
1571 WRITE(*,*)
'==========================='
1576 IF (control_double(4).GT.control_double(5)) goto 10
1585 CALL deallocate_cpo(coreprof_old)
1586 CALL copy_cpo(coreprof_iter, coreprof_old)
1587 CALL deallocate_cpo(equilibrium_old)
1588 CALL copy_cpo(equilibrium_iter, equilibrium_old)
1595 CALL deallocate_cpo(coreimpur_old)
1596 CALL copy_cpo(coreimpur_iter, coreimpur_old)
1600 CALL deallocate_cpo(coreneutrals_old)
1601 CALL copy_cpo(coreneutrals_iter, coreneutrals_old)
1603 IF (time + tau*0.1_r8 .GE. time_out)
THEN
1607 itime_out = itime_out +1
1608 time_out = time_out + tau_out
1610 CALL
write_out(itime_out, coreprof_iter )
1617 IF(shot_out.GT.0.AND.run_out.GE.0)
THEN
1619 IF(augment_equil.EQ.1)
THEN
1624 IF(use_euitm_put)
THEN
1626 coreprof_iter(1)%time=time
1627 WRITE(*,*)
'euitm_put_slice: coreprof', coreprof_iter(1)%time
1628 CALL euitm_put_slice(idx,
"coreprof",coreprof_iter(1))
1631 equilibrium_iter(1)%time=time
1632 WRITE(*,*)
'euitm_put_slice: equilibrium', equilibrium_iter(1)%time
1633 CALL euitm_put_slice(idx,
"equilibrium",equilibrium_iter(1))
1636 coretransp_iter(1)%time=time
1637 WRITE(*,*)
'euitm_put_slice: coretransp', coretransp_iter(1)%time
1638 CALL euitm_put_slice(idx,
"coretransp",coretransp_iter(1))
1640 coresource_iter(1)%time=time
1641 WRITE(*,*)
'euitm_put_slice: coresource', coresource_iter(1)%time
1642 CALL euitm_put_slice(idx,
"coresource",coresource_iter(1))
1645 coreimpur_iter(1)%time=time
1646 WRITE(*,*)
'euitm_put_slice: coreimpur', coreimpur_iter(1)%time
1647 CALL euitm_put_slice(idx,
"coreimpur",coreimpur_iter(1))
1651 coreneutrals_iter(1)%time=time
1652 WRITE(*,*)
'euitm_put_slice: coreneutrals', coreneutrals_iter(1)%time
1653 CALL euitm_put_slice(idx,
"coreneutrals",coreneutrals_iter(1))
1656 toroidfield_old(1)%time = time
1657 WRITE(*,*)
'euitm_put_slice: toroidfield', toroidfield_old(1)%time
1658 CALL euitm_put_slice(idx,
"toroidfield",toroidfield_old(1))
1663 IF(db_out .EQ.
"ascii")
THEN
1664 coreprof_iter(1)%time = time
1665 WRITE(filename,
'(a,''_'',I6.6,''_'',I6.6,''_'',I6.6,''.cpo'')')
'coreprof', shot_out, run_out, itime
1666 CALL open_write_file(1, trim(filename))
1667 CALL write_cpo(coreprof_iter(1),
'coreprof')
1668 CALL close_write_file
1670 equilibrium_iter(1)%time = time
1671 WRITE(filename,
'(a,''_'',I6.6,''_'',I6.6,''_'',I6.6,''.cpo'')')
'equilibrium', shot_out, run_out, itime
1672 CALL open_write_file(1, trim(filename))
1673 CALL write_cpo(equilibrium_iter(1),
'equilibrium')
1674 CALL close_write_file
1676 coretransp_iter(1)%time = time
1677 WRITE(filename,
'(a,''_'',I6.6,''_'',I6.6,''_'',I6.6,''.cpo'')')
'coretransp', shot_out, run_out, itime
1678 CALL open_write_file(1, trim(filename))
1679 CALL write_cpo(coretransp_iter(1),
'coretransp')
1680 CALL close_write_file
1681 coresource_iter(1)%time = time
1682 WRITE(filename,
'(a,''_'',I6.6,''_'',I6.6,''_'',I6.6,''.cpo'')')
'coresource', shot_out, run_out, itime
1683 CALL open_write_file(1, trim(filename))
1684 CALL write_cpo(coresource_iter(1),
'coresource')
1685 CALL close_write_file
1687 coreimpur_iter(1)%time = time
1688 WRITE(filename,
'(a,''_'',I6.6,''_'',I6.6,''_'',I6.6,''.cpo'')')
'coreimpur', shot_out, run_out, itime
1689 CALL open_write_file(1, trim(filename))
1690 CALL write_cpo(coreimpur_iter(1),
'coreimpur')
1691 CALL close_write_file
1694 coreneutrals_iter(1)%time = time
1695 WRITE(filename,
'(a,''_'',I6.6,''_'',I6.6,''_'',I6.6,''.cpo'')')
'coreneutrals', shot_out, run_out, itime
1696 CALL open_write_file(1, trim(filename))
1697 CALL write_cpo(coreneutrals_iter(1),
'coreneutrals')
1698 CALL close_write_file
1700 toroidfield_old(1)%time = time
1701 WRITE(filename,
'(a,''_'',I6.6,''_'',I6.6,''_'',I6.6,''.cpo'')')
'toroidfield', shot_out, run_out, itime
1702 CALL open_write_file(1, trim(filename))
1703 CALL write_cpo(toroidfield_old(1),
'toroidfield')
1704 CALL close_write_file
1709 WRITE(*,1000)
' AREA ',equilibrium_iter(1)%global_param%area
1710 WRITE(*,1000)
' VOLUME ',equilibrium_iter(1)%global_param%volume
1711 WRITE(*,1000)
' Raxis ',equilibrium_iter(1)%global_param%mag_axis%position%r
1712 WRITE(*,1000)
' Zaxis ',equilibrium_iter(1)%global_param%mag_axis%position%z
1713 WRITE(*,1000)
' Baxis ',equilibrium_iter(1)%global_param%mag_axis%bphi
1714 WRITE(*,1000)
' Rgeo ',equilibrium_iter(1)%eqgeometry%geom_axis%r
1715 WRITE(*,1000)
' Zgeo ',equilibrium_iter(1)%eqgeometry%geom_axis%z
1716 WRITE(*,1000)
' a ',equilibrium_iter(1)%eqgeometry%a_minor
1717 WRITE(*,1000)
' R0 ',equilibrium_iter(1)%global_param%toroid_field%b0
1718 WRITE(*,1000)
' B0 ',equilibrium_iter(1)%global_param%toroid_field%r0
1722 IF(iter_inc.GT.0 .AND. iter.LT.iter_inc)
THEN
1723 IF(tau_inc.GT.1.0_r8)
THEN
1725 WRITE(*,*)
'TAU, TAU_MAX ',tau,tau_max
1726 IF(tau_max.GT.0.0_r8) tau=min(tau,tau_max)
1727 WRITE(*,*)
'TAU increased to ',tau
1729 ELSEIF(iter_dec.GT.0 .AND. iter.GT.iter_dec)
THEN
1730 IF(tau_dec.GT.0.0_r8.AND.tau_dec.LT.1.0_r8)
THEN
1732 WRITE(*,*)
'TAU, TAU_MIN ',tau,tau_min
1733 IF(tau_min.GT.0.0_r8) tau=max(tau,tau_min)
1734 WRITE(*,*)
'TAU decreased to ',tau
1738 tau=min(tau,time_end-time)
1740 WRITE(*,*)
'ERROR: TAU < 0'
1744 WRITE(*,
'(a)')
'Global Diagnostics Start'
1745 WRITE(*,
'(a,1p,I10)')
'ITERATIONS ',iter
1746 WRITE(*,
'(a,1p,1024(1x,g15.6))')
' Ip ',equilibrium_new(1)%global_param%i_plasma
1747 WRITE(*,
'(a,1p,1024(1x,g15.6))')
' Vol ',equilibrium_new(1)%global_param%volume
1748 WRITE(*,
'(a,1p,1024(1x,g15.6))')
' Q_e(bnd) ',coreprof_iter(1)%te%flux%flux_dv(nrho)
1749 WRITE(*,
'(a,1p,1024(1x,g15.6))')
' G_e(bnd) ',coreprof_iter(1)%ne%flux%flux_dv(nrho)
1751 WRITE(*,
'(a,1p,a)')
' ION# ', iion
1752 WRITE(*,
'(a,1p,1024(1x,g15.6))')
' Q_i(bnd) ',coreprof_iter(1)%ti%flux%flux_dv(nrho,iion)
1753 WRITE(*,
'(a,1p,1024(1x,g15.6))')
' G_i(bnd) ',coreprof_iter(1)%ni%flux%flux_dv(nrho,iion)
1755 WRITE(*,
'(a)')
'Global Diagnostics End'
1761 WRITE(*,*)
'Core-Edge: Continuation call to SOLPS'
1762 CALL b2mn_ets(coreprof_old, coreimpur_old, coreneutrals_old, &
1763 coreprof_iter, coreimpur_iter, coreneutrals_iter, edge_new, &
1764 code_parameters_core_edge)
1766 IF(use_euitm_put)
THEN
1767 edge_new(1)%time = time
1768 WRITE(*,*)
'euitm_put_slice: edge', edge_new(1)%time
1769 CALL euitm_put_slice(idx,
"edge",edge_new(1))
1772 IF(db_out .EQ.
'ascii')
THEN
1773 edge_new(1)%time = time
1774 WRITE(filename,
'(a,''_'',I6.6,''_'',I6.6,''_'',I6.6,''.cpo'')')
'edge', shot_out, run_out, itime
1775 CALL open_write_file(1, trim(filename))
1776 CALL write_cpo(edge_new(1),
'edge')
1777 CALL close_write_file
1780 CALL deallocate_cpo(edge_new)
1783 INQUIRE(file=
'.quit',exist=quitexist)
1784 IF(quitexist)
EXIT time_loop
1790 WRITE(*,*)
'Core-Edge: Finalization call to SOLPS'
1791 CALL b2mn_ets(coreprof_old, coreimpur_old, coreneutrals_old, &
1792 coreprof_iter, coreimpur_iter, coreneutrals_iter, edge_new, &
1793 code_parameters_core_edge, .true.)
1797 IF(shot_out.GT.0.AND.run_out.GE.0.AND.db_out.NE.
'ascii')
THEN
1810 CALL deallocate_cpo(coreprof_old )
1811 CALL deallocate_cpo(coreprof_iter)
1814 CALL deallocate_cpo(equilibrium_old )
1815 CALL deallocate_cpo(equilibrium_iter)
1816 CALL deallocate_cpo(equilibrium_new )
1819 CALL deallocate_cpo(coretransp_iter)
1822 CALL deallocate_cpo(coresource_iter)
1824 IF(nimp .GT. 0) CALL deallocate_cpo(coreimpur_old )
1825 IF(nimp .GT. 0) CALL deallocate_cpo(coreimpur_iter)
1828 IF(nneut > 0) CALL deallocate_cpo(coreneutrals_old )
1829 IF(nneut > 0) CALL deallocate_cpo(coreneutrals_iter)
1830 IF(nneut > 0) CALL deallocate_cpo(coreneutrals_new)
1832 CALL deallocate_cpo(toroidfield_old )
1834 IF(
ASSOCIATED(evolution_labels))
DEALLOCATE(evolution_labels)
1835 IF(
ASSOCIATED(evolution_data))
DEALLOCATE(evolution_data)
1836 CALL deallocate_cpo(code_parameters_ets)
1837 CALL deallocate_cpo(code_parameters_ets_workflow)
1838 CALL deallocate_cpo(code_parameters_transport_combiner)
1839 CALL deallocate_cpo(code_parameters_sources_combiner)
1841 CALL deallocate_cpo(code_parameters_core_edge)
1844 CALL deallocate_cpo(coreprof_db)
1845 CALL deallocate_cpo(coretransp_db)
1846 CALL deallocate_cpo(coresource_db)
1847 IF(nimp.GT.0) CALL deallocate_cpo(coreimpur_db)
1848 IF(nneut.GT.0) CALL deallocate_cpo(coreneutrals_db)
1849 CALL deallocate_cpo(equilibrium_db)
1850 CALL deallocate_cpo(toroidfield_db)
1851 CALL deallocate_cpo(neoclassic_db)
1853 IF(
ALLOCATED(ets_species%nzimp))
DEALLOCATE(ets_species%nzimp)
1854 IF(
ALLOCATED(ets_species%ncomp))
DEALLOCATE(ets_species%ncomp)
1855 IF(
ALLOCATED(ets_species%ntype))
DEALLOCATE(ets_species%ntype)
1856 IF(
ALLOCATED(nzimp))
DEALLOCATE(nzimp)
1857 IF(
ALLOCATED(ncomp))
DEALLOCATE(ncomp)
1858 IF(
ALLOCATED(ntype))
DEALLOCATE(ntype)
1861 IF(nimp.GT.0) CALL impurity_finish
1864 WRITE(*,*)
'Total_size = ', total_size
1867 1000
FORMAT(a,1pg20.10)
1881 REAL(R8) :: r_in, r_out, el, tr_l, tr_u, ip
1884 INTEGER,
SAVE :: npts = 0, ncol, isrch=1
1885 INTEGER :: ipts, icol
1889 ncol=
SIZE(evolution_data,1)
1890 npts=
SIZE(evolution_data,2)
1891 WRITE(*,*)
'evolution: ncol, npts = ', ncol, npts
1894 DO WHILE (isrch.LT.npts .AND. t.GT.evolution_data(1,isrch+1))
1899 WRITE(*,*)
'Not enough data in "evolution.exp"'
1902 IF(t.LT.evolution_data(1,isrch).OR.isrch.EQ.npts)
THEN
1904 WRITE(*,*)
'Coding error in evolution, isrch <> 1'
1907 r_in = evolution_data(2,isrch)
1908 r_out = evolution_data(3,isrch)
1909 el = evolution_data(4,isrch)
1910 tr_l = evolution_data(5,isrch)
1911 tr_u = evolution_data(6,isrch)
1912 ip = evolution_data(7,isrch)
1914 tf=(t-evolution_data(1,isrch))/(evolution_data(1,isrch+1)-evolution_data(1,isrch))
1915 IF(tf.LT.0.0_r8 .OR. tf.GT.1.0_r8)
THEN
1916 WRITE(*,*)
'Coding error in evolution, tf not in [0,1], tf = ',tf
1918 r_in = (1.0_r8-tf)*evolution_data(2,isrch)+tf*evolution_data(2,isrch+1)
1919 r_out = (1.0_r8-tf)*evolution_data(3,isrch)+tf*evolution_data(3,isrch+1)
1920 el = (1.0_r8-tf)*evolution_data(4,isrch)+tf*evolution_data(4,isrch+1)
1921 tr_l = (1.0_r8-tf)*evolution_data(5,isrch)+tf*evolution_data(5,isrch+1)
1922 tr_u = (1.0_r8-tf)*evolution_data(6,isrch)+tf*evolution_data(6,isrch+1)
1923 ip = (1.0_r8-tf)*evolution_data(7,isrch)+tf*evolution_data(7,isrch+1)
1925 WRITE(*,*) evolution_labels(1), t
1926 WRITE(*,*) evolution_labels(2), r_in
1927 WRITE(*,*) evolution_labels(3), r_out
1928 WRITE(*,*) evolution_labels(4), el
1929 WRITE(*,*) evolution_labels(5), tr_l
1930 WRITE(*,*) evolution_labels(6), tr_u
1931 WRITE(*,*) evolution_labels(7), ip
1940 REAL(R8) :: x(:),
profile(1:size(x))
1941 CHARACTER (len=BUFLEN) :: function_string
1943 type(equationparser
) :: function_descriptor
1944 character(len=10) :: variables(1) = [
'x']
1948 function_descriptor = equationparser(trim(function_string), variables)
1955 profile(i) = function_descriptor%evaluate([x(i)])
1979 TYPE (type_equilibrium
),
POINTER :: equilibrium_iter(:)
1980 TYPE (type_coreprof
),
POINTER :: coreprof_iter(:)
1981 TYPE (type_coretransp
),
POINTER :: coretransp_iter(:), coretransp_etaigb(:), coretransp_neowes(:)
1982 TYPE (type_neoclassic
),
POINTER :: neoclassic_neowes(:)
1983 INTEGER,
PARAMETER :: nslice = 1
1984 INTEGER :: itr, iion, nrho, nion
1985 REAL(R8) :: add_transport
1987 nrho =
SIZE (coreprof_iter(1)%rho_tor, dim=1)
1989 CALL
allocate_coretransp_cpo(nslice, nrho, ets_species%NATM, ets_species%NION, ets_species%NIMP, ets_species%NZIMP, ets_species%NNEUT, ets_species%NTYPE, ets_species%NCOMP, coretransp_neowes )
1990 coretransp_neowes(1)%VALUES(1)%rho_tor(:) = coretransp_iter(1)%VALUES(1)%rho_tor(:)
1992 CALL
etaigb_wrapper(equilibrium_iter,coreprof_iter,coretransp_etaigb)
1993 CALL
neowes_wrapper(equilibrium_iter,coreprof_iter,neoclassic_neowes)
2017 coretransp_etaigb(1)%values(1)%te_transp%diff_eff(:),coretransp_etaigb(1)%values(1)%rho_tor,nrho, &
2018 coretransp_iter(1)%values(1)%te_transp%diff_eff(:),coretransp_iter(1)%values(1)%rho_tor,nrho)
2020 coretransp_etaigb(1)%values(1)%te_transp%vconv_eff(:),coretransp_etaigb(1)%values(1)%rho_tor,nrho, &
2021 coretransp_iter(1)%values(1)%te_transp%vconv_eff(:),coretransp_iter(1)%values(1)%rho_tor,nrho)
2023 neoclassic_neowes(1)%te_neo%diff_eff(:),neoclassic_neowes(1)%rho_tor,nrho, &
2024 coretransp_neowes(1)%values(1)%te_transp%diff_eff(:),coretransp_neowes(1)%values(1)%rho_tor,nrho)
2026 neoclassic_neowes(1)%te_neo%vconv_eff(:),neoclassic_neowes(1)%rho_tor,nrho, &
2027 coretransp_neowes(1)%values(1)%te_transp%vconv_eff(:),coretransp_neowes(1)%values(1)%rho_tor,nrho)
2028 coretransp_iter(1)%values(1)%te_transp%diff_eff = coretransp_iter(1)%values(1)%te_transp%diff_eff + &
2029 coretransp_neowes(1)%values(1)%te_transp%diff_eff + add_transport
2030 coretransp_iter(1)%values(1)%te_transp%vconv_eff = coretransp_iter(1)%values(1)%te_transp%vconv_eff + &
2031 coretransp_neowes(1)%values(1)%te_transp%vconv_eff
2034 coretransp_neowes(1)%values(1)%ni_transp%diff_eff=0.0_r8
2035 coretransp_neowes(1)%values(1)%ni_transp%vconv_eff=0.0_r8
2036 DO iion=1,ets_species%nion
2039 coretransp_etaigb(1)%values(1)%ni_transp%diff_eff(:,iion,itr),coretransp_etaigb(1)%values(1)%rho_tor,nrho, &
2040 coretransp_iter(1)%values(1)%ni_transp%diff_eff(:,iion,itr),coretransp_iter(1)%values(1)%rho_tor,nrho)
2042 coretransp_etaigb(1)%values(1)%ni_transp%vconv_eff(:,iion,itr),coretransp_etaigb(1)%values(1)%rho_tor,nrho, &
2043 coretransp_iter(1)%values(1)%ni_transp%vconv_eff(:,iion,itr),coretransp_iter(1)%values(1)%rho_tor,nrho)
2046 neoclassic_neowes(1)%ni_neo%diff_eff(:,iion),neoclassic_neowes(1)%rho_tor,nrho, &
2047 coretransp_neowes(1)%values(1)%ni_transp%diff_eff(:,iion,3),coretransp_neowes(1)%values(1)%rho_tor,nrho)
2049 neoclassic_neowes(1)%ni_neo%vconv_eff(:,iion),neoclassic_neowes(1)%rho_tor,nrho, &
2050 coretransp_neowes(1)%values(1)%ni_transp%vconv_eff(:,iion,3),coretransp_neowes(1)%values(1)%rho_tor,nrho)
2054 coretransp_etaigb(1)%values(1)%ti_transp%diff_eff(:,iion),coretransp_etaigb(1)%values(1)%rho_tor,nrho, &
2055 coretransp_iter(1)%values(1)%ti_transp%diff_eff(:,iion),coretransp_iter(1)%values(1)%rho_tor,nrho)
2057 coretransp_etaigb(1)%values(1)%ti_transp%vconv_eff(:,iion),coretransp_etaigb(1)%values(1)%rho_tor,nrho, &
2058 coretransp_iter(1)%values(1)%ti_transp%vconv_eff(:,iion),coretransp_iter(1)%values(1)%rho_tor,nrho)
2060 neoclassic_neowes(1)%ti_neo%diff_eff(:,iion),neoclassic_neowes(1)%rho_tor,nrho, &
2061 coretransp_neowes(1)%values(1)%ti_transp%diff_eff(:,iion),coretransp_neowes(1)%values(1)%rho_tor,nrho)
2063 neoclassic_neowes(1)%ti_neo%vconv_eff(:,iion),neoclassic_neowes(1)%rho_tor,nrho, &
2064 coretransp_neowes(1)%values(1)%ti_transp%vconv_eff(:,iion),coretransp_neowes(1)%values(1)%rho_tor,nrho)
2074 coretransp_iter(1)%values(1)%ni_transp%diff_eff = coretransp_iter(1)%values(1)%ni_transp%diff_eff + &
2075 coretransp_neowes(1)%values(1)%ni_transp%diff_eff + add_transport
2076 coretransp_iter(1)%values(1)%ni_transp%vconv_eff = coretransp_iter(1)%values(1)%ni_transp%vconv_eff + &
2077 coretransp_neowes(1)%values(1)%ni_transp%vconv_eff
2078 coretransp_iter(1)%values(1)%ti_transp%diff_eff = coretransp_iter(1)%values(1)%ti_transp%diff_eff + &
2079 coretransp_neowes(1)%values(1)%ti_transp%diff_eff + add_transport
2080 coretransp_iter(1)%values(1)%ti_transp%vconv_eff = coretransp_iter(1)%values(1)%ti_transp%vconv_eff + &
2081 coretransp_neowes(1)%values(1)%ti_transp%vconv_eff
2084 coretransp_iter(1)%values(1)%vtor_transp%diff_eff=coretransp_iter(1)%values(1)%ti_transp%diff_eff * 2.0_r8/3.0_r8
2085 coretransp_iter(1)%values(1)%vtor_transp%vconv_eff=coretransp_iter(1)%values(1)%ti_transp%vconv_eff * 2.0_r8/3.0_r8
2095 WRITE(*,*)
'coretransp_etaigb(1)%values(1)%te_transp%diff_eff ', &
2096 minval(coretransp_etaigb(1)%values(1)%te_transp%diff_eff), &
2097 maxval(coretransp_etaigb(1)%values(1)%te_transp%diff_eff)
2098 WRITE(*,*)
'coretransp_etaigb(1)%values(1)%te_transp%vconv_eff ' &
2099 ,minval( coretransp_etaigb(1)%values(1)%te_transp%vconv_eff), &
2100 maxval( coretransp_etaigb(1)%values(1)%te_transp%vconv_eff)
2101 WRITE(*,*)
'neoclassic_neowes(1)%te_neo%diff_eff ', &
2102 minval(neoclassic_neowes(1)%te_neo%diff_eff), &
2103 maxval(neoclassic_neowes(1)%te_neo%diff_eff)
2104 WRITE(*,*)
'neoclassic_neowes(1)%te_neo%vconv_eff ', &
2105 minval(neoclassic_neowes(1)%te_neo%vconv_eff), &
2106 maxval(neoclassic_neowes(1)%te_neo%vconv_eff)
2107 WRITE(*,*)
'coretransp_ITER(1)%values(1)%te_transp%diff_eff ', &
2108 minval(coretransp_iter(1)%values(1)%te_transp%diff_eff), &
2109 maxval(coretransp_iter(1)%values(1)%te_transp%diff_eff)
2110 WRITE(*,*)
'coretransp_ITER(1)%values(1)%te_transp%vconv_eff ', &
2111 minval(coretransp_iter(1)%values(1)%te_transp%vconv_eff), &
2112 maxval(coretransp_iter(1)%values(1)%te_transp%vconv_eff)
2113 WRITE(*,*)
'coretransp_etaigb(1)%values(1)%ti_transp%diff_eff ', &
2114 minval(coretransp_etaigb(1)%values(1)%ti_transp%diff_eff), &
2115 maxval(coretransp_etaigb(1)%values(1)%ti_transp%diff_eff)
2116 WRITE(*,*)
'coretransp_etaigb(1)%values(1)%ti_transp%vconv_eff ', &
2117 minval( coretransp_etaigb(1)%values(1)%ti_transp%vconv_eff), &
2118 maxval( coretransp_etaigb(1)%values(1)%ti_transp%vconv_eff)
2119 WRITE(*,*)
'neoclassic_neowes(1)%ti_neo%diff_eff ', &
2120 minval(neoclassic_neowes(1)%ti_neo%diff_eff), &
2121 maxval(neoclassic_neowes(1)%ti_neo%diff_eff)
2122 WRITE(*,*)
'neoclassic_neowes(1)%ti_neo%vconv_eff ', &
2123 minval(neoclassic_neowes(1)%ti_neo%vconv_eff), &
2124 maxval(neoclassic_neowes(1)%ti_neo%vconv_eff)
2125 WRITE(*,*)
'coretransp_ITER(1)%values(1)%ti_transp%diff_eff ', &
2126 minval(coretransp_iter(1)%values(1)%ti_transp%diff_eff), &
2127 maxval(coretransp_iter(1)%values(1)%ti_transp%diff_eff)
2128 WRITE(*,*)
'coretransp_ITER(1)%values(1)%ti_transp%vconv_eff ', &
2129 minval(coretransp_iter(1)%values(1)%ti_transp%vconv_eff), &
2130 maxval(coretransp_iter(1)%values(1)%ti_transp%vconv_eff)
2131 WRITE(*,*)
'coretransp_etaigb(1)%values(1)%ni_transp%diff_eff ', &
2132 minval(coretransp_etaigb(1)%values(1)%ni_transp%diff_eff), &
2133 maxval(coretransp_etaigb(1)%values(1)%ni_transp%diff_eff)
2134 WRITE(*,*)
'coretransp_etaigb(1)%values(1)%ni_transp%vconv_eff ', &
2135 minval( coretransp_etaigb(1)%values(1)%ni_transp%vconv_eff), &
2136 maxval( coretransp_etaigb(1)%values(1)%ni_transp%vconv_eff)
2137 WRITE(*,*)
'neoclassic_neowes(1)%ni_neo%diff_eff ', &
2138 minval(neoclassic_neowes(1)%ni_neo%diff_eff), &
2139 maxval(neoclassic_neowes(1)%ni_neo%diff_eff)
2140 WRITE(*,*)
'neoclassic_neowes(1)%ni_neo%vconv_eff ', &
2141 minval(neoclassic_neowes(1)%ni_neo%vconv_eff), &
2142 maxval(neoclassic_neowes(1)%ni_neo%vconv_eff)
2143 WRITE(*,*)
'coretransp_NEOWES(1)%values(1)%ni_transp%diff_eff ', &
2144 minval(coretransp_neowes(1)%values(1)%ni_transp%diff_eff), &
2145 maxval(coretransp_neowes(1)%values(1)%ni_transp%diff_eff)
2146 WRITE(*,*)
'coretransp_NEOWES(1)%values(1)%ni_transp%vconv_eff ', &
2147 minval(coretransp_neowes(1)%values(1)%ni_transp%vconv_eff), &
2148 maxval(coretransp_neowes(1)%values(1)%ni_transp%vconv_eff)
2149 WRITE(*,*)
'coretransp_ITER(1)%values(1)%ni_transp%diff_eff ', &
2150 minval(coretransp_iter(1)%values(1)%ni_transp%diff_eff), &
2151 maxval(coretransp_iter(1)%values(1)%ni_transp%diff_eff)
2152 WRITE(*,*)
'coretransp_ITER(1)%values(1)%ni_transp%vconv_eff ', &
2153 minval(coretransp_iter(1)%values(1)%ni_transp%vconv_eff), &
2154 maxval(coretransp_iter(1)%values(1)%ni_transp%vconv_eff)
2155 WRITE(*,*)
'coretransp_ITER(1)%values(1)%vtor_transp%diff_eff ', &
2156 minval(coretransp_iter(1)%values(1)%vtor_transp%diff_eff), &
2157 maxval(coretransp_iter(1)%values(1)%vtor_transp%diff_eff)
2158 WRITE(*,*)
'coretransp_ITER(1)%values(1)%vtor_transp%vconv_eff ', &
2159 minval(coretransp_iter(1)%values(1)%vtor_transp%vconv_eff), &
2160 maxval(coretransp_iter(1)%values(1)%vtor_transp%vconv_eff)
2162 CALL euitm_deallocate(coretransp_etaigb)
2163 CALL euitm_deallocate(coretransp_neowes)
2164 CALL euitm_deallocate(neoclassic_neowes)
subroutine check_convergence_neutrals(CORENEUTRALS_ITER, CORENEUTRALS_NEW, CONV)
Convergence check neutrals This routine checks the convergence of plasma profiles.
subroutine process_xml(SOLVER_TYPE, SIGMA_SOURCE, TAU, AMIX, CONVREC, NRHO, NION, NIMP, NZIMP, NTIME, NSOL, PSI_BND_TYPE, NI_BND_TYPE, TI_BND_TYPE, TE_BND_TYPE, VTOR_BND_TYPE, shot_no, run_no, codeparam, database_format)
process the xml version of the input file from codeparam
subroutine write_equilibrium(path, equilibrium_out)
subroutine convert_neoclassic2coresource(NEOCLASSIC, CORESOURCE)
subroutine changeradii(EQUILIBRIUM, COREPROF, CORETRANSP, CORESOURCE, COREIMPUR, CORENEUTRALS, NEOCLASSIC)
subroutine spitzer_resistivity(COREPROF_IN, CORETRANSP_OUT)
subroutine write_out(ITIME, COREPROF_NEW, COREPROF_ANALYTIC)
This subroutine stores the results of computations into files.
Module converts to/from CPOs to ETS types.
subroutine check_convergence(COREPROF_ITER, COREPROF_NEW, CONTROL_DOUBLE)
Convergence check This routine checks the convergence of plasma profiles.
subroutine writeoutneutrals(ITIME_OUT, CORENEUTRALS)
subroutine augment_psi_rz(equilibrium)
subroutine itm_ets(COREPROF_OLD, COREPROF_ITER, COREPROF_NEW, EQUILIBRIUM_OLD, EQUILIBRIUM_ITER, CORETRANSP, CORESOURCE, COREIMPUR, CONTROL_INTEGER, CONTROL_DOUBLE, code_parameters)
ETS.
subroutine impurity_ets(EQUILIBRIUM_ITER, COREPROF_ITER, CORETRANSP_ITER, COREIMPUR_OLD, COREIMPUR_ITER, CORENEUTRALS_ITER, CORESOURCE_ITER, CORESOURCE_NEW, COREIMPUR_NEW, CONTROL_INTEGER, CONTROL_DOUBLE)
subroutine fillcoreimpur(COREIMPUR_DB, COREIMPUR_GRID, COREIMPUR_OUT, INTERPOL)
subroutine fillcorefast(COREFAST_DB, COREFAST_GRID, COREFAST_OUT, INTERPOL)
subroutine synchrotron_radiation(COREPROF, CORESOURCE)
subroutine emeq_e3m_wrapper(EQUILIBRIUM_in, EQUILIBRIUM_out)
Module provides routines for testing.
subroutine fillcoresource(CORESOURCE_DB, CORESOURCE_GRID, CORESOURCE_OUT, INTERPOL)
subroutine l3interp(y_in, x_in, nr_in, y_out, x_out, nr_out)
Module provides the interface between (external) CPO and internal ETS derived types.
subroutine chease_wrapper(euitm_equilibrium_in, euitm_equilibrium_out)
subroutine fillcoreprof(COREPROF_DB, COREPROF_GRID, COREFAST_IN, COREPROF_OUT, INTERPOL)
Augment an inverse equilibrium with psi, Br, Bz and Bphi as a function of R and Z.
subroutine helena_wrapper(euitm_equilibrium_in, euitm_equilibrium_out)
subroutine combine_transport(COREPROF, CORETRANSP, CORETRANSP1, CORETRANSP2, CORETRANSP3, CORETRANSP4, CORETRANSP5, CORETRANSP_OUT, AMIX_TR, code_parameters)
subroutine convert_neoclassic2coretransp(NEOCLASSIC, CORETRANSP)
subroutine fillcoreneutrals(CORENEUTRALS_DB, CORENEUTRALS_GRID, CORENEUTRALS_OUT, INTERPOL)
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 external_transport(EQUILIBRIUM_ITER, COREPROF_ITER, CORETRANSP_ITER, add_transport)
subroutine fillcoretransp(CORETRANSP_DB, CORETRANSP_GRID, CORETRANSP_OUT, INTERPOL)
real(r8) function, dimension(1:size(x)) profile(function_string, x)
subroutine fillequilibrium(EQUILIBRIUM_DB, EQUILIBRIUM_GRID, EQUILIBRIUM_OUT, INTERPOL)
subroutine writeoutimpur(ITIME_OUT, COREIMPUR)
subroutine neowes_wrapper(eq, coreprof, neoclassic)
subroutine neutrals_ets(COREIMPUR_ITER, EQUILIBRIUM_ITER, COREPROF_ITER, CORENEUTRALS_OLD, CORENEUTRALS_ITER, CORESOURCE_NEW, CORENEUTRALS_NEW, CONTROL_INTEGER, CONTROL_DOUBLE)
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)
The module declares types of variables used in ETS (transport code)
subroutine set_coronal(COREIMPUR_IN, COREPROF_IN, COREIMPUR_OUT, INTERPOL, ICORONAL)
subroutine etaigb_wrapper(eq, coreprof, coretransp)
subroutine evolution(T, R_in, R_out, El, Tr_l, Tr_U, Ip)
subroutine gb_transport(EQUILIBRIUM, COREPROF, CORETRANSP)
subroutine check_convergence_impurities(COREIMPUR_ITER, COREIMPUR_NEW, CONV)
Convergence check impurities This routine checks the convergence of plasma profiles.
program ets_workflow
Framework for testing workflows built around the ETS.
Module provides the convergence check for the ETS.
subroutine gausian_sources(COREPROF, EQUILIBRIUM, CORESOURCE, code_parameters)
subroutine euitm_close(idx)
subroutine combine_sources(COREPROF, CORESOURCE, CORESOURCE1, CORESOURCE2, CORESOURCE3, CORESOURCE4, CORESOURCE5, CORESOURCE6, CORESOURCE7, CORESOURCE_OUT, AMIX_SRC, code_parameters)
subroutine start_profiles_consistency(PROF_FLAG, J0_FLAG, Q0_FLAG, EXT_EQUIL, COREPROF_IN, EQUILIBRIUM_IN, TOROIDFIELD_IN, COREPROF_OUT, EQUILIBRIUM_OUT)
subroutine allocate_coretransp_cpo(NSLICE, NRHO, NNUCL, NION, NIMP, NZIMP, NNEUT, NTYPE, NCOMP, CORETRANSP)
This routine allocates CORETRANSP CPO.