12 SUBROUTINE neutrals_ets (COREIMPUR_ITER, EQUILIBRIUM_ITER, COREPROF_ITER, &
13 coreneutrals_old, coreneutrals_iter, &
14 coresource_new, coreneutrals_new, &
15 control_integer, control_double)
38 USE deallocate_structures
56 TYPE (type_coreneutrals
),
POINTER :: coreneutrals_old(:)
57 TYPE (type_coreneutrals
),
POINTER :: coreneutrals_iter(:)
58 TYPE (type_coreneutrals
),
POINTER :: coreneutrals_new(:)
59 TYPE (type_equilibrium
),
POINTER :: equilibrium_iter(:)
60 TYPE (type_coreprof
),
POINTER :: coreprof_iter(:)
61 TYPE (type_coreimpur
),
POINTER :: coreimpur_iter(:)
62 TYPE (type_coresource
),
POINTER :: coresource_new(:)
70 INTEGER,
ALLOCATABLE :: nzimp(:)
71 INTEGER,
ALLOCATABLE :: nn_bnd_type(:,:)
74 INTEGER,
ALLOCATABLE :: ntype(:)
75 INTEGER,
ALLOCATABLE :: ncomp(:)
76 INTEGER,
PARAMETER :: nocur = 1
88 INTEGER :: hot_neutrals, cold_neutrals
92 REAL (R8),
ALLOCATABLE :: rho(:)
93 REAL (R8),
ALLOCATABLE :: aneut(:)
94 REAL (R8),
ALLOCATABLE :: vpr(:)
95 REAL (R8),
ALLOCATABLE :: vprm(:)
96 REAL (R8),
ALLOCATABLE :: g3(:)
97 REAL (R8),
ALLOCATABLE :: ne(:)
98 REAL (R8),
ALLOCATABLE :: te(:)
99 REAL (R8),
ALLOCATABLE :: ni(:,:)
100 REAL (R8),
ALLOCATABLE :: ti(:,:)
101 REAL (R8),
ALLOCATABLE :: dn0(:,:,:)
102 REAL (R8),
ALLOCATABLE ::
flux(:,:,:)
103 REAL (R8),
ALLOCATABLE :: flux_inter(:,:,:)
104 REAL (R8),
ALLOCATABLE :: n0(:,:,:)
105 REAL (R8),
ALLOCATABLE :: n0m(:,:,:)
106 REAL (R8),
ALLOCATABLE :: t0(:,:,:)
107 REAL (R8),
ALLOCATABLE :: vt(:,:,:)
108 REAL (R8),
ALLOCATABLE :: vr(:,:,:)
109 REAL (R8),
ALLOCATABLE :: vp(:,:,:)
110 REAL (R8),
ALLOCATABLE :: vconv(:,:,:)
111 REAL (R8),
ALLOCATABLE :: diff(:,:,:)
112 REAL (R8),
ALLOCATABLE :: nn_bnd(:,:,:)
113 REAL (R8),
ALLOCATABLE :: nnsource(:,:,:)
114 REAL (R8) :: amix, tau
117 INTEGER,
INTENT(IN) :: control_integer(1)
118 REAL (R8),
INTENT(IN) :: control_double(2)
119 INTEGER :: solut_method
122 INTEGER :: solver_type
123 REAL (R8),
ALLOCATABLE :: y(:)
124 REAL (R8),
ALLOCATABLE :: ym(:)
125 REAL (R8),
ALLOCATABLE :: dy(:)
126 REAL (R8),
ALLOCATABLE :: a(:)
127 REAL (R8),
ALLOCATABLE :: b(:)
128 REAL (R8),
ALLOCATABLE :: c(:)
129 REAL (R8),
ALLOCATABLE :: d(:)
130 REAL (R8),
ALLOCATABLE :: e(:)
131 REAL (R8),
ALLOCATABLE :: f(:)
132 REAL (R8),
ALLOCATABLE :: g(:)
134 REAL (R8) :: v(2), u(2), w(2)
135 REAL (R8),
ALLOCATABLE ::
fun(:), intfun(:)
139 REAL (R8),
ALLOCATABLE :: ionizat(:,:)
140 REAL (R8),
ALLOCATABLE :: recomb(:,:)
141 REAL (R8),
ALLOCATABLE :: potential(:,:)
142 REAL (R8),
ALLOCATABLE :: chargeexch(:,:)
143 REAL (R8),
ALLOCATABLE :: si_exp(:,:)
144 REAL (R8),
ALLOCATABLE :: ssi_exp(:,:)
145 REAL (R8),
ALLOCATABLE :: qi_exp(:,:)
146 REAL (R8),
ALLOCATABLE :: sz_exp(:,:,:)
147 REAL (R8),
ALLOCATABLE :: qz_exp(:,:,:)
148 REAL (R8),
ALLOCATABLE :: qe_exp(:)
149 REAL (R8),
ALLOCATABLE :: qe_exp_tot(:)
153 LOGICAL,
SAVE :: first = .true.
158 TYPE (amns_handle_type
),
SAVE :: amns
159 TYPE (amns_handle_rx_type
),
ALLOCATABLE,
SAVE :: amns_ei(:,:), amns_eip(:,:), amns_rc(:,:)
160 TYPE (amns_handle_rx_type
),
ALLOCATABLE,
SAVE :: amns_cx(:,:), amns_lr(:,:), amns_br(:,:)
161 TYPE (amns_version_type
) :: amns_database
162 TYPE (amns_reaction_type
) :: ei_rx, eip_rx, rc_rx, cx_rx, lr_rx, br_rx
163 TYPE (amns_reactants_type
) :: species
164 TYPE (amns_query_type
) :: query
165 TYPE (amns_answer_type
) :: answer
166 TYPE (amns_set_type
) :: set
167 REAL (R8) :: zn_neut, mi_neut
169 CHARACTER (len=80) :: format
177 neq =
SIZE (equilibrium_iter(1)%profiles_1d%rho_tor )
178 nrho =
SIZE (coreneutrals_iter(1)%rho_tor )
179 CALL
get_comp_dimensions(coreneutrals_iter(1)%COMPOSITIONS, nnucl, nion, nimp, nzimp, nneut, ntype, ncomp)
198 CALL copy_cpo(coreneutrals_iter(1), coreneutrals_new(1))
200 CALL deallocate_cpo(coresource_new(1)%COMPOSITIONS)
201 CALL copy_cpo(coreneutrals_iter(1)%COMPOSITIONS, coresource_new(1)%COMPOSITIONS)
207 coreneutrals_new(1)%datainfo%cocos = 13
208 coreneutrals_new(1)%time = coreprof_iter(1)%time
209 coreneutrals_new(1)%rho_tor = coreprof_iter(1)%rho_tor
210 coreneutrals_new(1)%rho_tor_norm = coreprof_iter(1)%rho_tor_norm
212 coresource_new(1)%datainfo%cocos = 13
213 coresource_new(1)%time = coreprof_iter(1)%time
214 coresource_new(1)%VALUES(1)%rho_tor = coreprof_iter(1)%rho_tor
215 coresource_new(1)%VALUES(1)%rho_tor_norm = coreprof_iter(1)%rho_tor_norm
228 ALLOCATE ( rho(nrho) )
229 ALLOCATE ( vpr(nrho) )
230 ALLOCATE ( vprm(nrho) )
231 ALLOCATE ( g3(nrho) )
232 ALLOCATE ( ne(nrho) )
233 ALLOCATE ( te(nrho) )
234 ALLOCATE ( ti(nrho,nion) )
235 ALLOCATE ( ni(nrho,nneut) )
237 ALLOCATE ( qe_exp(nrho) )
238 ALLOCATE ( qe_exp_tot(nrho) )
239 ALLOCATE ( si_exp(nrho,nion) )
240 ALLOCATE ( qi_exp(nrho,nion) )
241 ALLOCATE ( sz_exp(nrho,nimp,zmax) )
242 ALLOCATE ( qz_exp(nrho,nimp,zmax) )
243 ALLOCATE ( ssi_exp(nrho,nion) )
246 ALLOCATE ( ym(nrho) )
247 ALLOCATE ( dy(nrho) )
256 ALLOCATE (
fun(nrho) )
257 ALLOCATE ( intfun(nrho) )
259 ALLOCATE ( aneut(nneut) )
261 ALLOCATE ( n0(nrho,nneut,tmax) )
262 ALLOCATE ( n0m(nrho,nneut,tmax) )
263 ALLOCATE ( vconv(nrho,nneut,tmax) )
264 ALLOCATE ( diff(nrho,nneut,tmax) )
265 ALLOCATE ( dn0(nrho,nneut,tmax) )
266 ALLOCATE (
flux(nrho,nneut,tmax) )
267 ALLOCATE ( nn_bnd(3, nneut,tmax) )
268 ALLOCATE (nn_bnd_type( nneut,tmax) )
269 ALLOCATE ( t0(nrho,nneut,tmax) )
270 ALLOCATE ( vt(nrho,nneut,tmax) )
271 ALLOCATE ( vp(nrho,nneut,tmax) )
272 ALLOCATE ( vr(nrho,nneut,tmax) )
273 ALLOCATE ( nnsource(nrho,nneut,tmax) )
275 ALLOCATE ( ionizat(nrho,0:zmax) )
276 ALLOCATE ( recomb(nrho,0:zmax) )
277 ALLOCATE ( potential(nrho,0:zmax) )
278 ALLOCATE ( chargeexch(nrho,0:zmax) )
304 rho = coreprof_iter(1)%RHO_TOR
305 ne = coreprof_iter(1)%NE%VALUE
306 te = coreprof_iter(1)%TE%VALUE
309 ti(:,iion) = coreprof_iter(1)%TI%VALUE(:,iion)
312 amix = control_double(2)
313 tau = control_double(1)
314 solver_type = control_integer(1)
317 CALL
l3deriv(equilibrium_iter(1)%profiles_1d%volume, equilibrium_iter(1)%profiles_1d%rho_tor, neq, &
320 CALL
l3deriv(equilibrium_iter(1)%profiles_1d%volume, equilibrium_iter(1)%profiles_1d%rho_tor, neq, &
323 CALL
l3interp(equilibrium_iter(1)%profiles_1d%gm3, equilibrium_iter(1)%profiles_1d%rho_tor, neq, &
327 inucl = coreneutrals_old(1)%compositions%NEUTRALSCOMP(ineut)%NEUTCOMP(1)%nucindex
328 aneut(ineut) = coreneutrals_old(1)%compositions%nuclei(inucl)%amn
331 coreneutrals_iter(1)%PROFILES(ineut)%NEUTRALTYPE(1)%t0%value(:) = coreneutrals_iter(1)%PROFILES(ineut)%NEUTRALTYPE(1)%t0%boundary%value(1)
333 DO itype= 1, ntype(ineut)
334 CALL
l3interp(coreneutrals_iter(1)%PROFILES(ineut)%NEUTRALTYPE(itype)%n0%value, coreneutrals_iter(1)%rho_tor,
SIZE(coreneutrals_iter(1)%rho_tor), &
335 n0(:,ineut,itype), rho, nrho)
336 CALL
l3interp(coreneutrals_old(1)%PROFILES(ineut)%NEUTRALTYPE(itype)%n0%value, coreneutrals_iter(1)%rho_tor,
SIZE(coreneutrals_iter(1)%rho_tor), &
337 n0m(:,ineut,itype), rho, nrho)
338 CALL
l3interp(coreneutrals_iter(1)%PROFILES(ineut)%NEUTRALTYPE(itype)%t0%value, coreneutrals_iter(1)%rho_tor,
SIZE(coreneutrals_iter(1)%rho_tor), &
339 t0(:,ineut,itype), rho, nrho)
340 CALL
l3interp(coreneutrals_iter(1)%PROFILES(ineut)%NEUTRALTYPE(itype)%v0%toroidal%value, coreneutrals_iter(1)%rho_tor,
SIZE(coreneutrals_iter(1)%rho_tor), &
341 vt(:,ineut,itype), rho, nrho)
342 CALL
l3interp(coreneutrals_iter(1)%PROFILES(ineut)%NEUTRALTYPE(itype)%v0%poloidal%value, coreneutrals_iter(1)%rho_tor,
SIZE(coreneutrals_iter(1)%rho_tor), &
343 vp(:,ineut,itype), rho, nrho)
344 CALL
l3interp(coreneutrals_iter(1)%PROFILES(ineut)%NEUTRALTYPE(itype)%v0%radial%value, coreneutrals_iter(1)%rho_tor,
SIZE(coreneutrals_iter(1)%rho_tor), &
345 vr(:,ineut,itype), rho, nrho)
347 nn_bnd(:,ineut,itype) = coreneutrals_iter(1)%PROFILES(ineut)%NEUTRALTYPE(itype)%n0%boundary%value(:)
348 nn_bnd_type(ineut,itype) = coreneutrals_iter(1)%PROFILES(ineut)%NEUTRALTYPE(itype)%n0%boundary%type
353 IF(abs(aneut(ineut) - coreprof_iter(1)%compositions%nuclei(coreprof_iter(1)%compositions%IONS(iion)%nucindex)%amn).LE. 0.25)
THEN
354 ni(:,ineut) = coreprof_iter(1)%NI%VALUE(:,iion)
355 coreneutrals_iter(1)%PROFILES(ineut)%NEUTRALTYPE(2)%t0%value(:) = coreprof_iter(1)%TI%VALUE(:,iion)
360 IF(abs(aneut(ineut) - coreimpur_iter(1)%compositions%nuclei(coreimpur_iter(1)%compositions%IMPURITIES(iimp)%nucindex)%amn).LE. 0.25)
THEN
361 CALL
l3interp(coreimpur_iter(1)%IMPURITY(iimp)%NZ(:,1), coreimpur_iter(1)%rho_tor,
SIZE(coreimpur_iter(1)%rho_tor), &
362 ni(:,ineut), rho, nrho)
376 WRITE(*,*)
'ITM AMNSPROTO data used (via UAL)'
377 ALLOCATE(amns_ei(0:zmax, nneut), amns_rc(0:zmax, nneut), &
378 amns_eip(0:zmax,nneut), amns_lr(0:zmax, nneut), &
379 amns_br(0:zmax, nneut), amns_cx(0:zmax, nneut))
380 CALL itm_amns_setup(amns)
381 query%string =
'version'
382 CALL itm_amns_query(amns,query,answer)
383 WRITE(*,*)
'AMNS data base version = ',trim(answer%string)
385 eip_rx%string =
'EIP'
390 FORMAT =
'(''ZN = '',f5.2,'', IS = '',i2,'', RX = '',a,'', SRC = '',a)'
391 query%string =
'source'
395 inucl = coreneutrals_old(1)%compositions%NEUTRALSCOMP(ineut)%NEUTCOMP(1)%nucindex
396 zn_neut = coreneutrals_old(1)%compositions%nuclei(inucl)%zn
397 mi_neut = coreneutrals_old(1)%compositions%nuclei(inucl)%amn
401 IF (zn_neut .GE. iz)
THEN
403 allocate(species%components(4))
404 species%components = &
405 (/ amns_reactant_type(zn_neut, iz, mi_neut, 0), &
406 amns_reactant_type(0, -1, 0, 0), &
407 amns_reactant_type(zn_neut, iz+1, mi_neut, 1), &
408 amns_reactant_type(0, -1, 0, 1) &
410 CALL itm_amns_setup_table(amns, ei_rx, species, amns_ei(iz, ineut))
411 deallocate(species%components)
417 IF (zn_neut .GE. iz)
THEN
419 allocate(species%components(2))
420 species%components = &
421 (/ amns_reactant_type(zn_neut, iz, mi_neut, 0), &
422 amns_reactant_type(zn_neut, iz, mi_neut, 1) &
424 CALL itm_amns_setup_table(amns, eip_rx, species, amns_eip(iz, ineut))
425 deallocate(species%components)
431 IF (zn_neut .GE. iz)
THEN
433 allocate(species%components(4))
434 species%components = &
435 (/ amns_reactant_type(zn_neut, iz, mi_neut, 0), &
436 amns_reactant_type(1, 0, 0, 0), &
437 amns_reactant_type(zn_neut, iz-1, mi_neut, 1), &
438 amns_reactant_type(1, 1, 0, 1) &
440 CALL itm_amns_setup_table(amns, cx_rx, species, amns_cx(iz, ineut))
441 deallocate(species%components)
443 allocate(species%components(4))
444 species%components = &
445 (/ amns_reactant_type(zn_neut, iz, mi_neut, 0), &
446 amns_reactant_type(0, -1, 0, 0), &
447 amns_reactant_type(zn_neut, iz-1, mi_neut, 1), &
448 amns_reactant_type(0, -1, 0, 1) &
450 CALL itm_amns_setup_table(amns, rc_rx, species, amns_rc(iz, ineut))
451 deallocate(species%components)
468 neutral_type_loop1:
DO ineut=1,nneut
487 CALL itm_amns_rx(amns_ei(iz,ineut), ionizat(:,iz), te, ne)
490 CALL itm_amns_rx(amns_eip(iz,ineut), potential(:,iz), te, ne)
491 CALL itm_amns_rx(amns_rc(iz,ineut), recomb(:,iz), te, ne)
492 CALL itm_amns_rx(amns_cx(iz,ineut), chargeexch(:,iz), te, ne)
506 IF(
ASSOCIATED(coreneutrals_old(1)%compositions%neutralscomp(ineut)%type))
THEN
507 DO itype = 1, ntype(ineut)
508 IF (coreneutrals_old(1)%compositions%neutralscomp(ineut)%type(itype)%flag .EQ. 0) &
513 IF (cold_neutrals .EQ. 0) goto 123
523 nnsource(irho,ineut,itype) = 0.0
524 diff(irho,ineut,itype) = (9.56d7*t0(irho,ineut,itype)/aneut(ineut)) &
525 / (3.0*(ne(irho)*ionizat(irho,0)+chargeexch(irho,1)*ni(irho,ineut)))
551 y(irho) = n0(irho,ineut,itype)
552 ym(irho) = n0m(irho,ineut,itype)
556 d(irho) = vpr(irho)*g3(irho)*diff(irho,ineut,itype)
557 e(irho) = vpr(irho)*g3(irho)*vconv(irho,ineut,itype)
558 f(irho) = vpr(irho)*nnsource(irho,ineut,itype)
559 g(irho) = vpr(irho)*(ne(irho)*ionizat(irho,0)+ni(irho,ineut)*chargeexch(irho,1))
577 IF(nn_bnd_type(ineut,itype).EQ.1)
THEN
580 w(2) = nn_bnd(1,ineut,itype)
585 IF(nn_bnd_type(ineut,itype).EQ.2)
THEN
588 w(2) = nn_bnd(1,ineut,itype)
592 IF(nn_bnd_type(ineut,itype).EQ.3)
THEN
593 v(2) = nn_bnd(1,ineut,itype)
599 IF(nn_bnd_type(ineut,itype).EQ.4)
THEN
600 v(2) = -g3(nrho)*diff(nrho,ineut,itype)*vpr(nrho)
601 u(2) = g3(nrho)*vconv(nrho,ineut,itype)*vpr(nrho)
602 w(2) = nn_bnd(1,ineut,itype)
607 IF(nn_bnd_type(ineut,itype).EQ.5)
THEN
608 v(2) = nn_bnd(1,ineut,itype)
609 u(2) = nn_bnd(2,ineut,itype)
610 w(2) = nn_bnd(3,ineut,itype)
616 IF (nn_bnd_type(ineut,itype).EQ.0)
THEN
617 CALL
l3deriv(y, rho, nrho, dy, rho, nrho)
621 rho_loop4:
DO irho=1,nrho
640 solver%EQ_FLAG(ndim) = flag
646 rho_loop5:
DO irho=1,nrho
648 solver%RHO(irho) = rho(irho)
649 solver%Y(ndim,irho) = y(irho)
650 solver%DY(ndim,irho) = dy(irho)
651 solver%YM(ndim,irho) = ym(irho)
652 solver%A(ndim,irho) = a(irho)
653 solver%B(ndim,irho) = b(irho)
654 solver%C(ndim,irho) = c(irho)
655 solver%D(ndim,irho) = d(irho)
656 solver%E(ndim,irho) = e(irho)
657 solver%F(ndim,irho) = f(irho)
658 solver%G(ndim,irho) = g(irho)
677 rho_loop6:
DO irho=1,nrho
678 y(irho) =
solver%Y(ndim,irho)
679 dy(irho) =
solver%DY(ndim,irho)
685 rho_loop7:
DO irho=1,nrho
687 n0m(irho,ineut,itype) = n0(irho,ineut,itype)
689 n0(irho,ineut,itype) = y(irho)
690 dn0(irho,ineut,itype) = dy(irho)
691 fun(irho) = 1.d0/rho(irho)*(vpr(irho)*nnsource(irho,ineut,itype) &
692 + vprm(irho)*n0m(irho,ineut,itype)/tau &
693 - n0(irho,ineut,itype)*vpr(irho)*(1.d0/tau))
694 flux(irho,ineut,itype) = vpr(irho)*g3(irho)* &
695 ( y(irho)*vconv(irho,ineut,itype) - dy(irho)*diff(irho,ineut,itype))
705 IF(
ASSOCIATED(coreneutrals_old(1)%compositions%neutralscomp(ineut)%type))
THEN
706 DO itype = 1, ntype(ineut)
707 IF (coreneutrals_old(1)%compositions%neutralscomp(ineut)%type(itype)%flag .EQ. 1) &
712 IF (hot_neutrals .EQ. 0) goto 124
718 nnsource(irho,ineut,itype)=0.0
723 diff(irho,ineut,itype)=(9.56d7*t0(irho,ineut,itype)/aneut(ineut))/(3.0*(ne(irho)*ionizat(irho,0)+chargeexch(irho,1)*ni(irho,ineut)))
748 rho_loop8:
DO irho=1,nrho
749 y(irho) = n0(irho,ineut,itype)
750 ym(irho) = n0m(irho,ineut,itype)
754 d(irho) = vpr(irho)*g3(irho)*diff(irho,ineut,itype)
755 e(irho) = vpr(irho)*g3(irho)*vconv(irho,ineut,itype)
756 f(irho) = vpr(irho)*nnsource(irho,ineut,itype)+ &
757 vpr(irho)*ni(irho,ineut)*chargeexch(irho,1)*n0(irho,ineut,1)+ &
758 vpr(irho)*ni(irho,ineut)*ne(irho)*recomb(irho,1)
759 g(irho) = vpr(irho)*(ni(irho,ineut)*chargeexch(irho,1)+ne(irho)*ionizat(irho,0))
778 IF(nn_bnd_type(ineut,itype).EQ.1)
THEN
781 w(2) = nn_bnd(1,ineut,itype)
785 IF(nn_bnd_type(ineut,itype).EQ.2)
THEN
788 w(2) = nn_bnd(1,ineut,itype)
792 IF(nn_bnd_type(ineut,itype).EQ.3)
THEN
793 v(2) = nn_bnd(1,ineut,itype)
799 IF(nn_bnd_type(ineut,itype).EQ.4)
THEN
800 v(2) = -g3(nrho)*diff(nrho,ineut,itype)*vpr(nrho)
801 u(2) = g3(nrho)*vconv(nrho,ineut,itype)*vpr(nrho)
802 w(2) = nn_bnd(1,ineut,itype)
807 IF(nn_bnd_type(ineut,itype).EQ.5)
THEN
808 v(2) = nn_bnd(1,ineut,itype)
809 u(2) = nn_bnd(2,ineut,itype)
810 w(2) = nn_bnd(3,ineut,itype)
816 IF(nn_bnd_type(ineut,itype).EQ.0)
THEN
818 CALL
l3deriv(y, rho, nrho, dy, rho, nrho)
822 rho_loop9:
DO irho=1,nrho
842 solver%EQ_FLAG(ndim) = flag
848 rho_loop10:
DO irho=1,nrho
850 solver%RHO(irho) = rho(irho)
851 solver%Y(ndim,irho) = y(irho)
852 solver%DY(ndim,irho) = dy(irho)
853 solver%YM(ndim,irho) = ym(irho)
854 solver%A(ndim,irho) = a(irho)
855 solver%B(ndim,irho) = b(irho)
856 solver%C(ndim,irho) = c(irho)
857 solver%D(ndim,irho) = d(irho)
858 solver%E(ndim,irho) = e(irho)
859 solver%F(ndim,irho) = f(irho)
860 solver%G(ndim,irho) = g(irho)
879 rho_loop11:
DO irho=1,nrho
881 y(irho) =
solver%Y(ndim,irho)
882 dy(irho) =
solver%DY(ndim,irho)
888 rho_loop12:
DO irho=1,nrho
890 n0m(irho,ineut,itype) = n0(irho,ineut,itype)
891 n0(irho,ineut,itype) = y(irho)
892 dn0(irho,ineut,itype) = dy(irho)
893 fun(irho) = 1.d0/rho(irho)*(vpr(irho)*nnsource(irho,ineut,itype) &
894 + vprm(irho)*n0m(irho,ineut,itype)/tau &
895 - n0(irho,ineut,itype)*vpr(irho)*(1.d0/tau))
896 flux(irho,ineut,itype) = vpr(irho)*g3(irho)* &
897 ( y(irho)*vconv(irho,ineut,itype) - dy(irho)*diff(irho,ineut,itype))
905 IF(abs(aneut(ineut)-coreprof_iter(1)%compositions%nuclei(coreprof_iter(1)%compositions%IONS(iion)%nucindex)%amn).LE.0.25)
THEN
906 DO itype=1,ntype(ineut)
907 si_exp(irho,iion) = si_exp(irho,iion)+ne(irho)*(n0(irho,ineut,itype)*ionizat(irho,0)-recomb(irho,1)*ni(irho,ineut))
912 IF (
ASSOCIATED(coresource_new(1)%VALUES(1)%sz))
THEN
915 IF(abs(aneut(ineut)-coreimpur_iter(1)%compositions%nuclei(coreimpur_iter(1)%compositions%IMPURITIES(iimp)%nucindex)%amn).LE.0.25)
THEN
916 DO itype=1,ntype(ineut)
917 sz_exp(irho,iimp,1) = sz_exp(irho,iimp,1)+ne(irho)*(n0(irho,ineut,itype)*ionizat(irho,0)-recomb(irho,1)*ni(irho,ineut))
932 IF(abs(aneut(ineut)-coreprof_iter(1)%compositions%nuclei(coreprof_iter(1)%compositions%IONS(iion)%nucindex)%amn).LE.0.25)
THEN
933 DO itype=1,ntype(ineut)
935 qe_exp(irho) = qe_exp(irho) - 1.5_r8 * itm_ev * &
936 (ionizat(irho,0) * potential(irho,1) * n0(irho,ineut,itype) * ne(irho))
938 qi_exp(irho,iion) = qi_exp(irho,iion) + 1.5_r8 * itm_ev * &
939 (chargeexch(irho,1) * (t0(irho,ineut,itype)-ti(irho,iion)) * n0(irho,ineut,itype) * ni(irho,ineut))
944 qe_exp_tot(irho) = qe_exp_tot(irho) + qe_exp(irho)
949 IF (
ASSOCIATED(coresource_new(1)%VALUES(1)%sz))
THEN
952 IF(abs(aneut(ineut)-coreimpur_iter(1)%compositions%nuclei(coreimpur_iter(1)%compositions%IMPURITIES(iimp)%nucindex)%amn).LE.0.25)
THEN
953 DO itype=1,ntype(ineut)
955 qe_exp(irho) = qe_exp(irho) - 1.5_r8 * itm_ev * &
956 ( ionizat(irho,0) * potential(irho,1) * n0(irho,ineut,itype) * ne(irho))
959 qz_exp(irho,iimp,1)= qz_exp(irho,iimp,1) + 1.5_r8 * itm_ev * &
960 (chargeexch(irho,1) * (t0(irho,ineut,itype)-ti(irho,1)) * n0(irho,ineut,itype) * ni(irho,ineut))
968 qe_exp_tot(irho) = qe_exp_tot(irho) + qe_exp(irho)
990 loop_irho20:
DO irho=1,nrho
991 DO itype=1,ntype(ineut)
992 coreneutrals_new(1)%PROFILES(ineut)%NEUTRALTYPE(itype)%n0%value(irho) = n0(irho,ineut,itype)
993 coreneutrals_new(1)%PROFILES(ineut)%NEUTRALTYPE(itype)%n0%flux(irho) =
flux(irho,ineut,itype)
998 IF(abs(aneut(ineut)-coreprof_iter(1)%compositions%nuclei(coreprof_iter(1)%compositions%IONS(iion)%nucindex)%amn).LE.0.25)
THEN
999 coresource_new(1)%VALUES(1)%si%exp(irho,iion) = si_exp(irho,iion)
1000 coresource_new(1)%VALUES(1)%qi%exp(irho,iion) = qi_exp(irho,iion)
1002 coresource_new(1)%VALUES(1)%qe%exp(irho) = qe_exp(irho)
1004 coresource_new(1)%VALUES(1)%se%exp(irho) = coresource_new(1)%VALUES(1)%se%exp(irho) + &
1005 coresource_new(1)%VALUES(1)%si%exp(irho,iion)
1010 IF (
ASSOCIATED(coresource_new(1)%VALUES(1)%sz))
THEN
1012 IF(abs(aneut(ineut)-coreimpur_iter(1)%compositions%nuclei(coreimpur_iter(1)%compositions%IMPURITIES(iimp)%nucindex)%amn).LE.0.25)
THEN
1013 coresource_new(1)%VALUES(1)%sz(iimp)%exp(irho,1) = sz_exp(irho,iimp,1)
1014 coresource_new(1)%VALUES(1)%se%exp(irho) = coresource_new(1)%VALUES(1)%se%exp(irho) + &
1015 coresource_new(1)%VALUES(1)%sz(iimp)%exp(irho,1)
1021 coresource_new(1)%VALUES(1)%qe%exp(irho) = qe_exp_tot(irho)
1030 END DO neutral_type_loop1
1035 coreneutrals_new(1)%PROFILES(ineut)%prad0 = 0.d0
1039 DO itype=1,ntype(ineut)
1040 coreneutrals_new(1)%PROFILES(ineut)%prad0(irho) = coreneutrals_new(1)%PROFILES(ineut)%prad0(irho) + &
1041 itm_ev * ionizat(irho,0) * potential(irho,1) * n0(irho,ineut,itype) * ne(irho)
1053 ALLOCATE (coresource_new(1)%VALUES(1)%sourceid%id(1))
1054 ALLOCATE (coresource_new(1)%VALUES(1)%sourceid%description(1))
1055 coresource_new(1)%VALUES(1)%sourceid%id =
'gaspuff'
1056 coresource_new(1)%VALUES(1)%sourceid%flag = 21
1057 coresource_new(1)%VALUES(1)%sourceid%description =
'Gas puff'
1068 DEALLOCATE ( qe_exp )
1069 DEALLOCATE ( qe_exp_tot )
1070 DEALLOCATE ( si_exp )
1071 DEALLOCATE ( qi_exp )
1072 DEALLOCATE ( sz_exp )
1073 DEALLOCATE ( qz_exp )
1074 DEALLOCATE (ssi_exp )
1088 DEALLOCATE (intfun )
1089 DEALLOCATE ( aneut )
1093 DEALLOCATE ( vconv )
1097 DEALLOCATE ( nn_bnd )
1098 DEALLOCATE (nn_bnd_type )
1103 DEALLOCATE ( nnsource )
1105 DEALLOCATE ( ionizat )
1106 DEALLOCATE ( recomb )
1107 DEALLOCATE ( potential )
1108 DEALLOCATE ( chargeexch )
1110 WRITE (*,*)
'NEUTRALS finished <==========='
1134 TYPE (type_coreneutrals
),
POINTER :: coreneutrals(:)
1139 integer :: itime_out
1142 INTEGER :: ntype,itype
1143 REAL (R8),
ALLOCATABLE :: rho(:)
1146 CHARACTER (33) filename
1149 nrho =
SIZE (coreneutrals(1)%RHO_TOR, dim=1)
1150 nneut =
SIZE (coreneutrals(1)%profiles,dim=1)
1152 ALLOCATE (rho(nrho))
1154 rho = coreneutrals(1)%RHO_TOR
1156 IF (nneut.GE.2)
THEN
1157 WRITE(*,*)
'in programe Write neutrals'
1158 WRITE(*,*)
'CORENEUTRALS(1)%profiles(1)%neutraltype(1)%n0%value(NRHO)=',coreneutrals(1)%profiles(1)%neutraltype(1)%n0%value(nrho)
1163 ntype =
SIZE(coreneutrals(1)%profiles(ineut)%neutraltype)
1165 WRITE(*,*)
'ntype=',ntype,
'irena'
1167 WRITE(filename,
'(a,i1.1,a,i7.7,a)')
'eq_ets_data/OUTNE',ineut,
'/NEU',itime_out,
'.DAT'
1168 OPEN (unit=20, file=filename)
1171 WRITE (20,
'(100(1x,e14.7))')rho(irho),(coreneutrals(1)%profiles(ineut)%neutraltype(itype)%n0%value(irho),itype=1,ntype),&
1172 coreneutrals(1)%profiles(ineut)%prad0(irho)
subroutine l3deriv(y_in, x_in, nr_in, dydx_out, x_out, nr_out)
subroutine solution_interface(SOLVER, ifail)
INTERFACE TO NUMERICAL SOLVER.
subroutine writeoutneutrals(ITIME_OUT, CORENEUTRALS)
subroutine get_comp_dimensions(COMPOSITIONS, NNUCL, NION, NIMP, NZIMP, NNEUT, NTYPE, NCOMP)
subroutine allocate_numerics(NDIM, NRHO, SOLVER, ifail)
subroutine flux(psitok, rk, zk, nk)
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 neutrals_ets(COREIMPUR_ITER, EQUILIBRIUM_ITER, COREPROF_ITER, CORENEUTRALS_OLD, CORENEUTRALS_ITER, CORESOURCE_NEW, CORENEUTRALS_NEW, CONTROL_INTEGER, CONTROL_DOUBLE)
The module declares types of variables used in ETS (transport code)
subroutine allocate_coreneutrals_cpo(NSLICE, NRHO, NNUCL, NION, NIMP, NZIMP, NNEUT, NTYPE, NCOMP, CORENEUTRALS)