ETS  \$Id: Doxyfile 2162 2020-02-26 14:16:09Z g2dpc $
 All Classes Files Functions Variables Pages
coronal.f90
Go to the documentation of this file.
1 MODULE coronal
2 
3 CONTAINS
4 ! + + + + + + + + + + + + + + + + + + + + + + + + + + + +
5 ! + + + + + + + + + + + + + + + + + + + + + + + + + + + +
6  SUBROUTINE set_coronal(COREIMPUR_IN, COREPROF_IN, COREIMPUR_OUT, INTERPOL, ICORONAL)
7 
8 
9 ! +++ Declaration of variables:
10  USE euitm_schemas
11  USE euitm_routines
12  USE copy_structures
14  USE itm_types
15 
16 
17  IMPLICIT NONE
18 
19  INTEGER, PARAMETER :: nslice = 1 !number of CPO ocurancies in the work flow
20  INTEGER :: nrho, nrho2, irho
21  INTEGER :: nnucl,inucl
22  INTEGER :: nion, nzimp1
23  INTEGER :: nimp, iimp
24  INTEGER, ALLOCATABLE :: nzimp(:)
25  INTEGER :: izimp
26  INTEGER :: nneut
27  INTEGER, ALLOCATABLE :: ncomp(:)
28  INTEGER, ALLOCATABLE :: ntype(:)
29 
30 
31  INTEGER :: interpol !interpolation index "0"-based on RHO_TOR; all other - based on RHO_TOR_NORM
32  INTEGER :: icoronal !interpolation index: "0"-OFF; "1" - replace boundary conditions by coronal; "2" - replace boundary conditions and profiles by coronal
33 
34 ! +++ CPO derived types:
35  TYPE (type_coreimpur), POINTER :: coreimpur_in(:) !input CPO with impurity
36  TYPE (type_coreprof), POINTER :: coreprof_in(:) !input CPO with plasma profiles
37  TYPE (type_coreimpur), POINTER :: coreimpur_out(:) !output CPO with sources uploaded from the data base
38 
39 
40 ! +++ Internal derived types:
41  REAL (R8), ALLOCATABLE :: rho(:), rho2(:), ne(:), te(:), n_impurity(:,:), nzt_impurity(:)
42  REAL (R8) :: nimp_tot, amn, zn
43 
44 
45 
46 ! + + + + + + + + + + + + + + + + + + + + + + + + + + + +
47 ! +++ allocate and define grid of output CPO:
48  nrho = SIZE (coreimpur_in(1)%rho_tor, dim=1)
49  nrho2 = SIZE (coreprof_in(1)%rho_tor, dim=1)
50 
51  CALL get_comp_dimensions(coreimpur_in(1)%COMPOSITIONS, nnucl, nion, nimp, nzimp, nneut, ntype, ncomp)
52  IF(.NOT.(ASSOCIATED(coreimpur_out)))&
53 !! CALL ALLOCATE_COREIMPUR_CPO (NSLICE, NRHO, NNUCL, NION, NIMP, NZIMP, NNEUT, NTYPE, NCOMP, COREIMPUR_OUT) !! overwritten by next line
54  CALL copy_cpo(coreimpur_in, coreimpur_out)
55 
56 
57  IF(icoronal .EQ. 0) goto 10
58 
59 
60  ALLOCATE ( rho(nrho))
61  ALLOCATE ( rho2(nrho2))
62 
63  IF (interpol.EQ.0) THEN
64  rho = coreimpur_in(1)%rho_tor
65  rho2 = coreprof_in(1)%rho_tor
66  ELSE
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)
69  END IF
70 
71 
72 
73 
74 ! + + + + + + + + + + + + + + + + + + + + + + + + + + + +
75  ALLOCATE ( te(nrho))
76  ALLOCATE ( ne(nrho))
77 
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)
82 
83  IF (coreprof_in(1)%te%boundary%type .EQ. 1) te(nrho) = coreprof_in(1)%te%boundary%value(1)
84 
85 
86 
87 ! + + + + + + + + + + + + + + + + + + + + + + + + + + + +
88  DO iimp = 1, nimp
89  inucl = coreimpur_in(1)%COMPOSITIONS%IMPURITIES(iimp)%nucindex
90 
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
95 
96  IF (ALLOCATED(n_impurity)) DEALLOCATE(n_impurity)
97  ALLOCATE (n_impurity(nrho,nzimp(iimp)))
98 
99  IF (ALLOCATED(nzt_impurity)) DEALLOCATE(nzt_impurity)
100  ALLOCATE (nzt_impurity(nrho))
101 
102 
103 
104  nzimp1 = nzimp(iimp)
105  CALL coronal_distribution(nrho, ne, te, amn, zn, nzimp1, n_impurity)
106 
107  DO irho = 1,nrho
108  DO izimp = 1,nzimp(iimp)
109  IF (n_impurity(nrho,izimp).LE.1.0d-200) n_impurity(nrho,izimp) = 0._r8
110  ENDDO
111  ENDDO
112 
113 ! Replace boundary conditions by coronal
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
119  END DO
120 
121 
122 ! Replace boundary conditions and concentration profiles by coronal
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
128 
129  coreimpur_out(1)%IMPURITY(iimp)%nz(:,izimp) = n_impurity(:,izimp)*nimp_tot
130 
131  coreimpur_out(1)%IMPURITY(iimp)%z(:,izimp) = izimp
132  coreimpur_out(1)%IMPURITY(iimp)%zsq(:,izimp) = izimp**2
133 
134  END DO
135 
136  ! experimental
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
140  !NZT_IMPURITY(:) = SUM(COREIMPUR_IN(1)%impurity(IIMP)%z(:,:) * COREIMPUR_IN(1)%impurity(IIMP)%nz(:,:), &
141  ! dim=2)
142  nzt_impurity(:) = sum(coreimpur_in(1)%impurity(iimp)%nz(:,:), &
143  dim=2)
144 
145  ! N_IMPURITY(:,IZIMP)*NZT_IMPURITY(:)
146  ! NZ_IMPURITY(:) = SUM(COREIMPUR_IN(1)%impurity(IIMP)%z(:,:) * COREIMPUR_IN(1)%impurity(IIMP)%nz(:,:), &
147 
148  DO izimp = 1,nzimp(iimp)
149  coreimpur_out(1)%IMPURITY(iimp)%nz(:,izimp) = n_impurity(:,izimp)*nzt_impurity(:)
150 
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
154 
155  coreimpur_out(1)%IMPURITY(iimp)%z(:,izimp) = izimp
156  coreimpur_out(1)%IMPURITY(iimp)%zsq(:,izimp) = izimp**2
157 
158  END DO
159  ELSE
160  DO izimp = 1,nzimp(iimp)
161  coreimpur_out(1)%IMPURITY(iimp)%nz(:,izimp) = 0.0_r8
162 
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
166 
167  coreimpur_out(1)%IMPURITY(iimp)%z(:,izimp) = izimp
168  coreimpur_out(1)%IMPURITY(iimp)%zsq(:,izimp) = izimp**2
169 
170  END DO
171  ENDIF
172 
173  END IF
174 
175  END DO
176 
177 
178 
179 
180  IF (ALLOCATED(n_impurity)) DEALLOCATE (n_impurity)
181  IF (ALLOCATED(nzt_impurity)) DEALLOCATE (nzt_impurity)
182  DEALLOCATE (te)
183  DEALLOCATE (ne)
184  DEALLOCATE (rho)
185  DEALLOCATE (rho2)
186 
187 
188  10 RETURN
189 
190 
191  END SUBROUTINE set_coronal
192 ! + + + + + + + + + + + + + + + + + + + + + + + + + + + +
193 ! + + + + + + + + + + + + + + + + + + + + + + + + + + + +
194 
195 
196 
197 
198 
199 
200 ! + + + + + + + + + + + + + + + + + + + + + + + + + + + +
201 ! + + + + + + + + + + + + + + + + + + + + + + + + + + + +
202 SUBROUTINE coronal_distribution (NRHO, NE, TE, AMN, ZN, NZIMP1, N_IMPURITY)
203  USE itm_types
204  USE amns_types
205  USE amns_module
206 
207 
208  IMPLICIT NONE
209 
210  INTEGER :: nzimp1
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
227 !================================================================================
228 
229 
230 
231  mi = amn
232  mi = 0
233  ns = nzimp1
234 
235 ! some initializations
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))
240 
241 ! set up the AMNS system
242 
243  CALL itm_amns_setup(amns)
244  WRITE(*,*) 'Done ITM_AMNS_SETUP'
245 
246 ! set up tables for ionization
247  xx_rx%string='EI'
248  DO is=0,ns
249  IF(is .NE. zn) THEN
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) &
256  /)
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
262  ENDIF
263  ENDDO
264 
265 ! set up tables for line radiation
266  xx_rx%string='LR'
267  DO is=0,ns
268  IF(is .NE. zn) THEN
269  allocate(species%components(2))
270  species%components = &
271  (/ amns_reactant_type(zn, is, mi, 0), &
272  amns_reactant_type(zn, is, mi, 1) &
273  /)
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
279  ENDIF
280  ENDDO
281 
282 ! set up tables for recombination
283  xx_rx%string='RC'
284  DO is=0,ns
285  IF(is .NE. 0) THEN
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) &
292  /)
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
298  ENDIF
299  ENDDO
300 
301 ! set up tables for recombination radiation
302  xx_rx%string='BR'
303  DO is=0,ns
304  IF(is .NE. 0) THEN
305  allocate(species%components(2))
306  species%components = &
307  (/ amns_reactant_type(zn, is, mi, 0), &
308  amns_reactant_type(zn, is, mi, 1) &
309  /)
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
315  ENDIF
316  ENDDO
317 
318  WRITE(*,*) 'Done ITM_AMNS_SETUP_TABLE'
319 
320 ! interpolate ionization and line radiation data
321  set%string='nowarn'
322  DO is=0,ns
323  IF(is .NE. zn) THEN
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)
328  ENDIF
329  ENDDO
330 
331 ! interpolate recombination and recombination radiation data
332  set%string='nowarn'
333  DO is=0,ns
334  IF(is .NE. 0) THEN
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)
339  ENDIF
340  ENDDO
341 
342  WRITE(*,*) 'Done ITM_AMNS_RX'
343 
344 ! finalize the tables
345  DO is=0,ns
346  IF(is .NE. zn) THEN
347  CALL itm_amns_finish_table(amns_ei(is))
348  CALL itm_amns_finish_table(amns_lr(is))
349  ENDIF
350  ENDDO
351  DO is=0,ns
352  IF(is .NE. 0) THEN
353  CALL itm_amns_finish_table(amns_rc(is))
354  CALL itm_amns_finish_table(amns_br(is))
355  ENDIF
356  ENDDO
357 
358  WRITE(*,*) 'Done ITM_AMNS_FINISH_TABLE'
359 
360 ! finalize the system
361  CALL itm_amns_finish(amns)
362 
363  WRITE(*,*) 'Done ITM_AMNS_FINISH'
364 
365  OPEN(10,file='coronal.out')
366  WRITE(10,'(100a15)') '#te ',state_labels, &
367  ' LR ', &
368  ' BR '
369 
370  DO irho=1, nrho
371 
372 ! set up the matrix
373  l(0)=0.0_r8
374  d(0)=-rate_ei(irho,0)
375  u(0)=rate_rc(irho,1)
376  rhs(0)=0.0_r8
377  DO is=1,ns-1
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)
381  rhs(is)=0.0_r8
382  ENDDO
383  l(ns)=rate_ei(irho,ns-1)
384  d(ns)=-rate_rc(irho,ns)
385  u(ns)=0.0_r8
386  rhs(ns)=0.0_r8
387 
388 ! we need to set the value of 1 charge state
389  isref=0
390  DO is=1, ns-1
391  IF(rate_ei(irho,is) .LT. rate_rc(irho,is)) THEN
392  EXIT
393  ELSE
394  isref=isref+1
395  ENDIF
396  ENDDO
397 ! write(*,*) te(IRHO), isref
398  u(isref)=0.0_r8
399  d(isref)=1.0_r8
400  l(isref)=0.0_r8
401  rhs(isref)=1.0_r8
402 
403 ! solve (l,d,u) na = rhs
404  CALL solve_tridiag(l,d,u,rhs,na,ns+1)
405  na(:) = na(:) / sum(na)
406 
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))
409 
410 ! OUTPUT DENSITIES:
411  DO is=1,ns
412  n_impurity(irho,is) = na(is)
413  ENDDO
414 
415 
416 ! check the answer
417 
418  norm=max(maxval(rate_ei(irho,0:ns-1) * na(0:ns-1)), maxval(rate_rc(irho,1:ns) * na(1:ns)))
419  is=0
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
422  DO is=1, ns-1
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
425  ENDDO
426  is=ns
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
429 
430 
431  ENDDO
432  CLOSE(10)
433 
434 
435  RETURN
436 
437 
438 END SUBROUTINE coronal_distribution
439 
440 
441 SUBROUTINE solve_tridiag(a,b,c,v,x,n)
442  USE itm_types
443  IMPLICIT NONE
444 ! a - sub-diagonal (means it is the diagonal below the main diagonal)
445 ! b - the main diagonal
446 ! c - sup-diagonal (means it is the diagonal above the main diagonal)
447 ! v - right part
448 ! x - the answer
449 ! n - number of equations
450 
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
455  REAL(kind=R8) :: m
456  INTEGER i
457 
458 ! Make copies of the b and v variables so that they are unaltered by this sub
459  bp(1) = b(1)
460  vp(1) = v(1)
461 
462  !The first pass (setting coefficients):
463  firstpass: DO i = 2,n
464  m = a(i)/bp(i-1)
465  bp(i) = b(i) - m*c(i-1)
466  vp(i) = v(i) - m*vp(i-1)
467  END DO firstpass
468 
469  x(n) = vp(n)/bp(n)
470  !The second pass (back-substition)
471  backsub:DO i = n-1, 1, -1
472  x(i) = (vp(i) - c(i)*x(i+1))/bp(i)
473  END DO backsub
474 
475 END SUBROUTINE solve_tridiag
476 ! + + + + + + + + + + + + + + + + + + + + + + + + + + + +
477 ! + + + + + + + + + + + + + + + + + + + + + + + + + + + +
478 
479 
480 
481 ! + + + + + + + + + + + + + + + + + + + + + + + + + + + +
482 ! + + + + + + + + + + + + + + + + + + + + + + + + + + + +
483 
484 END MODULE coronal
subroutine coronal_distribution(NRHO, NE, TE, AMN, ZN, NZIMP1, N_IMPURITY)
Definition: coronal.f90:202
subroutine get_comp_dimensions(COMPOSITIONS, NNUCL, NION, NIMP, NZIMP, NNEUT, NTYPE, NCOMP)
subroutine solve_tridiag(a, b, c, v, x, n)
Definition: coronal.f90:441
subroutine l3interp(y_in, x_in, nr_in, y_out, x_out, nr_out)
Definition: l3interp.f90:1
This module contains routines for allocation/deallocation if CPOs used in ETS.
subroutine set_coronal(COREIMPUR_IN, COREPROF_IN, COREIMPUR_OUT, INTERPOL, ICORONAL)
Definition: coronal.f90:6