6 SUBROUTINE set_coronal(COREIMPUR_IN, COREPROF_IN, COREIMPUR_OUT, INTERPOL, ICORONAL)
19 INTEGER,
PARAMETER :: nslice = 1
20 INTEGER :: nrho, nrho2, irho
21 INTEGER :: nnucl,inucl
22 INTEGER :: nion, nzimp1
24 INTEGER,
ALLOCATABLE :: nzimp(:)
27 INTEGER,
ALLOCATABLE :: ncomp(:)
28 INTEGER,
ALLOCATABLE :: ntype(:)
35 TYPE (type_coreimpur
),
POINTER :: coreimpur_in(:)
36 TYPE (type_coreprof
),
POINTER :: coreprof_in(:)
37 TYPE (type_coreimpur
),
POINTER :: coreimpur_out(:)
41 REAL (R8),
ALLOCATABLE :: rho(:), rho2(:), ne(:), te(:), n_impurity(:,:), nzt_impurity(:)
42 REAL (R8) :: nimp_tot, amn, zn
48 nrho =
SIZE (coreimpur_in(1)%rho_tor, dim=1)
49 nrho2 =
SIZE (coreprof_in(1)%rho_tor, dim=1)
51 CALL
get_comp_dimensions(coreimpur_in(1)%COMPOSITIONS, nnucl, nion, nimp, nzimp, nneut, ntype, ncomp)
52 IF(.NOT.(
ASSOCIATED(coreimpur_out)))&
54 CALL copy_cpo(coreimpur_in, coreimpur_out)
57 IF(icoronal .EQ. 0) goto 10
61 ALLOCATE ( rho2(nrho2))
63 IF (interpol.EQ.0)
THEN
64 rho = coreimpur_in(1)%rho_tor
65 rho2 = coreprof_in(1)%rho_tor
67 rho = coreimpur_in(1)%rho_tor / coreimpur_in(1)%rho_tor(nrho)
68 rho2 = coreprof_in(1)%rho_tor / coreprof_in(1)%rho_tor(nrho2)
78 IF (
ASSOCIATED(coreprof_in(1)%ne%value)) &
79 CALL
l3interp(coreprof_in(1)%ne%value, rho2, nrho2, ne, rho, nrho)
80 IF (
ASSOCIATED(coreprof_in(1)%te%value)) &
81 CALL
l3interp(coreprof_in(1)%te%value, rho2, nrho2, te, rho, nrho)
83 IF (coreprof_in(1)%te%boundary%type .EQ. 1) te(nrho) = coreprof_in(1)%te%boundary%value(1)
89 inucl = coreimpur_in(1)%COMPOSITIONS%IMPURITIES(iimp)%nucindex
91 zn = coreimpur_in(1)%COMPOSITIONS%NUCLEI(inucl)%zn
92 amn = coreimpur_in(1)%COMPOSITIONS%NUCLEI(inucl)%amn
93 nimp_tot = sum(coreimpur_in(1)%IMPURITY(iimp)%boundary%value(1,:))
94 write(*,*)
'set_coronal: iimp, NIMP_TOT = ', iimp, nimp_tot
96 IF (
ALLOCATED(n_impurity))
DEALLOCATE(n_impurity)
97 ALLOCATE (n_impurity(nrho,nzimp(iimp)))
99 IF (
ALLOCATED(nzt_impurity))
DEALLOCATE(nzt_impurity)
100 ALLOCATE (nzt_impurity(nrho))
108 DO izimp = 1,nzimp(iimp)
109 IF (n_impurity(nrho,izimp).LE.1.0d-200) n_impurity(nrho,izimp) = 0._r8
114 IF(icoronal .EQ. 1)
THEN
115 DO izimp = 1,nzimp(iimp)
116 coreimpur_out(1)%IMPURITY(iimp)%boundary%value(1,izimp) = n_impurity(nrho,izimp)*nimp_tot
117 coreimpur_out(1)%IMPURITY(iimp)%boundary%value(2,izimp) = 0.0_r8
118 coreimpur_out(1)%IMPURITY(iimp)%boundary%value(3,izimp) = 0.0_r8
123 ELSE IF(icoronal .EQ. 2)
THEN
124 DO izimp = 1,nzimp(iimp)
125 coreimpur_out(1)%IMPURITY(iimp)%boundary%value(1,izimp) = n_impurity(nrho,izimp)*nimp_tot
126 coreimpur_out(1)%IMPURITY(iimp)%boundary%value(2,izimp) = 0.0_r8
127 coreimpur_out(1)%IMPURITY(iimp)%boundary%value(3,izimp) = 0.0_r8
129 coreimpur_out(1)%IMPURITY(iimp)%nz(:,izimp) = n_impurity(:,izimp)*nimp_tot
131 coreimpur_out(1)%IMPURITY(iimp)%z(:,izimp) = izimp
132 coreimpur_out(1)%IMPURITY(iimp)%zsq(:,izimp) = izimp**2
137 ELSE IF(icoronal .EQ. 3)
THEN
138 IF (
ASSOCIATED(coreimpur_in(1)%impurity(iimp)%nz) .and. &
139 ASSOCIATED(coreimpur_in(1)%impurity(iimp)%z))
THEN
142 nzt_impurity(:) = sum(coreimpur_in(1)%impurity(iimp)%nz(:,:), &
148 DO izimp = 1,nzimp(iimp)
149 coreimpur_out(1)%IMPURITY(iimp)%nz(:,izimp) = n_impurity(:,izimp)*nzt_impurity(:)
151 coreimpur_out(1)%IMPURITY(iimp)%boundary%value(1,izimp) = coreimpur_out(1)%IMPURITY(iimp)%nz(nrho,izimp)
152 coreimpur_out(1)%IMPURITY(iimp)%boundary%value(2,izimp) = 0.0_r8
153 coreimpur_out(1)%IMPURITY(iimp)%boundary%value(3,izimp) = 0.0_r8
155 coreimpur_out(1)%IMPURITY(iimp)%z(:,izimp) = izimp
156 coreimpur_out(1)%IMPURITY(iimp)%zsq(:,izimp) = izimp**2
160 DO izimp = 1,nzimp(iimp)
161 coreimpur_out(1)%IMPURITY(iimp)%nz(:,izimp) = 0.0_r8
163 coreimpur_out(1)%IMPURITY(iimp)%boundary%value(1,izimp) = 0.0_r8
164 coreimpur_out(1)%IMPURITY(iimp)%boundary%value(2,izimp) = 0.0_r8
165 coreimpur_out(1)%IMPURITY(iimp)%boundary%value(3,izimp) = 0.0_r8
167 coreimpur_out(1)%IMPURITY(iimp)%z(:,izimp) = izimp
168 coreimpur_out(1)%IMPURITY(iimp)%zsq(:,izimp) = izimp**2
180 IF (
ALLOCATED(n_impurity))
DEALLOCATE (n_impurity)
181 IF (
ALLOCATED(nzt_impurity))
DEALLOCATE (nzt_impurity)
211 INTEGER :: nrho, irho
212 TYPE (amns_handle_type
) :: amns
213 type (amns_handle_rx_type),
ALLOCATABLE :: amns_ei(:), amns_rc(:), amns_lr(:), amns_br(:)
214 type (amns_reaction_type) :: xx_rx
215 TYPE (amns_reactants_type
) :: species
216 TYPE (amns_query_type
) :: query
217 TYPE (amns_answer_type
) :: answer
218 TYPE (amns_set_type
) :: set
219 REAL (kind=R8) :: te(nrho), ne(nrho), n_impurity(nrho,nzimp1)
220 REAL (kind=R8),
ALLOCATABLE :: na(:), rhs(:)
221 REAL (kind=R8),
ALLOCATABLE :: rate_ei(:,:), rate_rc(:,:), rate_lr(:,:), rate_br(:,:)
222 REAL (kind=R8),
ALLOCATABLE :: l(:), d(:), u(:)
223 REAL (kind=R8) :: zn, mi, amn
224 REAL (kind=R8) :: test, norm, line_radiation, recombination_radiation
225 CHARACTER (len=12),
ALLOCATABLE :: state_labels(:)
226 INTEGER :: ns, is, isref
236 ALLOCATE(amns_ei(0:ns), amns_rc(0:ns), amns_lr(0:ns), amns_br(0:ns))
237 ALLOCATE(state_labels(0:ns))
238 ALLOCATE(l(0:ns), d(0:ns), u(0:ns), na(0:ns), rhs(0:ns))
239 ALLOCATE(rate_ei(1:nrho,0:ns), rate_rc(1:nrho,0:ns), rate_lr(1:nrho,0:ns), rate_br(1:nrho,0:ns))
243 CALL itm_amns_setup(amns)
244 WRITE(*,*)
'Done ITM_AMNS_SETUP'
250 allocate(species%components(4))
251 species%components = &
252 (/ amns_reactant_type(zn, is, mi, 0), &
253 amns_reactant_type(0, -1, 0, 0), &
254 amns_reactant_type(zn, is+1, mi, 1), &
255 amns_reactant_type(0, -1, 0, 1) &
257 CALL itm_amns_setup_table(amns, xx_rx, species, amns_ei(is))
258 deallocate(species%components)
259 query%string=
'state_label'
260 CALL itm_amns_query_table(amns_ei(is),query,answer)
261 state_labels(is)=answer%string
269 allocate(species%components(2))
270 species%components = &
271 (/ amns_reactant_type(zn, is, mi, 0), &
272 amns_reactant_type(zn, is, mi, 1) &
274 CALL itm_amns_setup_table(amns, xx_rx, species, amns_lr(is))
275 deallocate(species%components)
276 query%string=
'state_label'
277 CALL itm_amns_query_table(amns_lr(is),query,answer)
278 state_labels(is)=answer%string
286 allocate(species%components(4))
287 species%components = &
288 (/ amns_reactant_type(zn, is, mi, 0), &
289 amns_reactant_type(0, -1, 0, 0), &
290 amns_reactant_type(zn, is-1, mi, 1), &
291 amns_reactant_type(0, -1, 0, 1) &
293 CALL itm_amns_setup_table(amns, xx_rx, species, amns_rc(is))
294 deallocate(species%components)
295 query%string=
'state_label'
296 CALL itm_amns_query_table(amns_rc(is),query,answer)
297 state_labels(is)=answer%string
305 allocate(species%components(2))
306 species%components = &
307 (/ amns_reactant_type(zn, is, mi, 0), &
308 amns_reactant_type(zn, is, mi, 1) &
310 CALL itm_amns_setup_table(amns, xx_rx, species, amns_br(is))
311 deallocate(species%components)
312 query%string=
'state_label'
313 CALL itm_amns_query_table(amns_br(is),query,answer)
314 state_labels(is)=answer%string
318 WRITE(*,*)
'Done ITM_AMNS_SETUP_TABLE'
324 CALL itm_amns_set_table(amns_ei(is),set)
325 CALL itm_amns_rx(amns_ei(is),rate_ei(:,is),te,ne)
326 CALL itm_amns_set_table(amns_lr(is),set)
327 CALL itm_amns_rx(amns_lr(is),rate_lr(:,is),te,ne)
335 CALL itm_amns_set_table(amns_rc(is),set)
336 CALL itm_amns_rx(amns_rc(is),rate_rc(:,is),te,ne)
337 CALL itm_amns_set_table(amns_br(is),set)
338 CALL itm_amns_rx(amns_br(is),rate_br(:,is),te,ne)
342 WRITE(*,*)
'Done ITM_AMNS_RX'
347 CALL itm_amns_finish_table(amns_ei(is))
348 CALL itm_amns_finish_table(amns_lr(is))
353 CALL itm_amns_finish_table(amns_rc(is))
354 CALL itm_amns_finish_table(amns_br(is))
358 WRITE(*,*)
'Done ITM_AMNS_FINISH_TABLE'
361 CALL itm_amns_finish(amns)
363 WRITE(*,*)
'Done ITM_AMNS_FINISH'
365 OPEN(10,file=
'coronal.out')
366 WRITE(10,
'(100a15)')
'#te ',state_labels, &
374 d(0)=-rate_ei(irho,0)
378 l(is)=rate_ei(irho,is-1)
379 d(is)=-rate_ei(irho,is)-rate_rc(irho,is)
380 u(is)=rate_rc(irho,is+1)
383 l(ns)=rate_ei(irho,ns-1)
384 d(ns)=-rate_rc(irho,ns)
391 IF(rate_ei(irho,is) .LT. rate_rc(irho,is))
THEN
405 na(:) = na(:) / sum(na)
407 line_radiation = sum(na(0:ns-1)*rate_lr(irho,0:ns-1))
408 recombination_radiation = sum(na(1:ns)*rate_br(irho,1:ns))
412 n_impurity(irho,is) = na(is)
418 norm=max(maxval(rate_ei(irho,0:ns-1) * na(0:ns-1)), maxval(rate_rc(irho,1:ns) * na(1:ns)))
420 test = (-rate_ei(irho,is) * na(is) + rate_rc(irho,is+1) * na(is+1))/norm
421 IF(abs(test).GT.1e-15_r8)
WRITE(*,*)
'LARGE ERROR: ',irho, is, test
423 test = (rate_ei(irho,is-1) * na(is-1) - (rate_rc(irho,is) + rate_ei(irho,is)) * na(is) + rate_rc(irho,is+1) * na(is+1))/norm
424 IF(abs(test).GT.1e-15_r8)
WRITE(*,*)
'LARGE ERROR: ',irho, is, test
427 test = (rate_ei(irho,is-1) * na(is-1) - rate_rc(irho,is) * na(is))/norm
428 IF(abs(test).GT.1e-15_r8)
WRITE(*,*)
'LARGE ERROR: ',irho, is, test
451 INTEGER,
INTENT(in) :: n
452 REAL(kind=R8),
DIMENSION(n),
INTENT(in) :: a,b,c,v
453 REAL(kind=R8),
DIMENSION(n),
INTENT(out) :: x
454 REAL(kind=R8),
DIMENSION(n) :: bp,vp
463 firstpass:
DO i = 2,n
465 bp(i) = b(i) - m*c(i-1)
466 vp(i) = v(i) - m*vp(i-1)
471 backsub:
DO i = n-1, 1, -1
472 x(i) = (vp(i) - c(i)*x(i+1))/bp(i)
subroutine coronal_distribution(NRHO, NE, TE, AMN, ZN, NZIMP1, N_IMPURITY)
subroutine get_comp_dimensions(COMPOSITIONS, NNUCL, NION, NIMP, NZIMP, NNEUT, NTYPE, NCOMP)
subroutine solve_tridiag(a, b, c, v, x, n)
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 set_coronal(COREIMPUR_IN, COREPROF_IN, COREIMPUR_OUT, INTERPOL, ICORONAL)