8 SUBROUTINE gausian_sources (COREPROF, EQUILIBRIUM, CORESOURCE, code_parameters)
32 USE deallocate_structures
41 TYPE (type_equilibrium
),
POINTER :: equilibrium(:)
42 TYPE (type_coreprof
),
POINTER :: coreprof(:)
43 TYPE (type_coresource
),
POINTER :: coresource(:)
44 TYPE (type_param
) :: code_parameters
49 REAL(R8),
ALLOCATABLE :: amn(:)
50 REAL(R8),
ALLOCATABLE :: zn(:)
51 REAL(R8),
ALLOCATABLE :: zion(:)
52 REAL(R8),
ALLOCATABLE :: rho(:)
53 REAL(R8),
ALLOCATABLE :: vprime(:)
54 REAL(R8),
ALLOCATABLE :: jni(:)
55 REAL(R8),
ALLOCATABLE :: qel(:)
56 REAL(R8),
ALLOCATABLE :: qion(:,:)
57 REAL(R8),
ALLOCATABLE :: sel(:)
58 REAL(R8),
ALLOCATABLE :: sion(:,:)
59 REAL(R8),
ALLOCATABLE :: uion(:,:)
64 INTEGER,
PARAMETER :: nslice = 1
70 INTEGER,
ALLOCATABLE :: nzimp(:)
72 INTEGER,
ALLOCATABLE :: ncomp(:)
73 INTEGER,
ALLOCATABLE :: ntype(:)
82 nrho =
SIZE (coreprof(1)%rho_tor, dim=1)
83 npsi =
SIZE (equilibrium(1)%profiles_1d%rho_tor, dim=1)
85 CALL
get_comp_dimensions(coreprof(1)%COMPOSITIONS, nnucl, nion, nimp, nzimp, nneut, ntype, ncomp)
89 CALL deallocate_cpo(coresource(1)%COMPOSITIONS)
90 CALL copy_cpo(coreprof(1)%COMPOSITIONS, coresource(1)%COMPOSITIONS)
94 ALLOCATE ( amn(nion2) )
95 ALLOCATE ( zn(nion2) )
96 ALLOCATE ( zion(nion2) )
97 ALLOCATE ( rho(nrho) )
98 ALLOCATE ( vprime(nrho) )
99 ALLOCATE ( jni(nrho) )
100 ALLOCATE ( qel(nrho) )
101 ALLOCATE ( qion(nrho,nion2))
102 ALLOCATE ( sel(nrho) )
103 ALLOCATE ( sion(nrho,nion2))
104 ALLOCATE ( uion(nrho,nion2))
122 time = coreprof(1)%time
124 rho = coreprof(1)%rho_tor
126 r0 = equilibrium(1)%global_param%toroid_field%r0
128 CALL
l3deriv(equilibrium(1)%profiles_1d%volume, equilibrium(1)%profiles_1d%rho_tor, npsi, &
134 CALL
additional_source(amn, zn, zion, nrho, rho, r0, vprime, nion2, qel, qion, sel, sion, uion, jni, code_parameters)
138 nion2 = min(
SIZE(amn),
SIZE(zn),
SIZE(zion))
142 coresource(1)%time = time
144 coresource(1)%VALUES(1)%rho_tor = rho
146 coresource(1)%VALUES(1)%j = jni
148 coresource(1)%VALUES(1)%qe%exp = qel
149 coresource(1)%VALUES(1)%qe%imp = 0.0e0_r8
151 coresource(1)%VALUES(1)%se%exp = sel
152 coresource(1)%VALUES(1)%se%imp = 0.0e0_r8
155 inucl = coresource(1)%COMPOSITIONS%IONS(iion1)%nucindex
157 IF (abs(amn(iion2) - coresource(1)%COMPOSITIONS%NUCLEI(inucl)%amn) .LE. 0.25 .AND. &
158 abs(zn(iion2) - coresource(1)%COMPOSITIONS%NUCLEI(inucl)%zn ) .LE. 0.25 .AND. &
159 abs(zion(iion2) - coresource(1)%COMPOSITIONS%IONS(iion1)%zion ) .LE. 0.25)
THEN
161 coresource(1)%VALUES(1)%si%exp(:,iion1) = sion(:,iion2)
162 coresource(1)%VALUES(1)%si%imp(:,iion1) = 0.0e0_r8
164 coresource(1)%VALUES(1)%qi%exp(:,iion1) = qion(:,iion2)
165 coresource(1)%VALUES(1)%qi%imp(:,iion1) = 0.0e0_r8
167 coresource(1)%VALUES(1)%ui%exp(:,iion1) = uion(:,iion2)
168 coresource(1)%VALUES(1)%ui%imp(:,iion1) = 0.0e0_r8
177 ALLOCATE (coresource(1)%VALUES(1)%sourceid%id(1))
178 ALLOCATE (coresource(1)%VALUES(1)%sourceid%description(1))
179 coresource(1)%VALUES(1)%sourceid%id =
'gaussian'
180 coresource(1)%VALUES(1)%sourceid%flag = 33
181 coresource(1)%VALUES(1)%sourceid%description =
'Gaussian'
186 IF(
ALLOCATED(amn))
DEALLOCATE (amn)
187 IF(
ALLOCATED(rho))
DEALLOCATE (rho)
188 IF(
ALLOCATED(vprime))
DEALLOCATE (vprime)
189 IF(
ALLOCATED(jni))
DEALLOCATE (jni)
190 IF(
ALLOCATED(qel))
DEALLOCATE (qel)
191 IF(
ALLOCATED(qion))
DEALLOCATE (qion)
192 IF(
ALLOCATED(sel))
DEALLOCATE (sel)
193 IF(
ALLOCATED(sion))
DEALLOCATE (sion)
194 IF(
ALLOCATED(uion))
DEALLOCATE (uion)
195 IF(
ALLOCATED(nzimp))
DEALLOCATE (nzimp)
196 IF(
ALLOCATED(ncomp))
DEALLOCATE (ncomp)
197 IF(
ALLOCATED(ntype))
DEALLOCATE (ntype)
221 SUBROUTINE additional_source (AMN, ZN, ZION, NRHO, RHO, R0, VPRIME, NION, QEL, QION, SEL, SION, UION, JNI, code_parameters)
236 INTEGER :: nrho, irho
241 REAL(R8) :: rho(nrho)
242 REAL(R8) :: vprime(nrho)
244 REAL(R8) :: amn(nion)
246 REAL(R8) :: zion(nion)
248 REAL(R8) :: jni(nrho)
249 REAL(R8) :: qel(nrho)
250 REAL(R8) :: qion(nrho,nion)
251 REAL(R8) :: sel(nrho)
252 REAL(R8) :: sion(nrho,nion)
253 REAL(R8) :: uion(nrho,nion)
256 REAL(R8) :: gfun(nrho)
257 REAL(R8) :: a, c, w, intfun
271 REAL(R8) :: fwheat_el
274 REAL(R8) :: wtot(nion)
275 REAL(R8) :: rheat(nion)
276 REAL(R8) :: fwheat(nion)
281 REAL(R8) :: fwpart_el
284 REAL(R8) :: stot(nion)
285 REAL(R8) :: rpart(nion)
286 REAL(R8) :: fwpart(nion)
289 REAL(R8) :: utot(nion)
290 REAL(R8) :: rmom(nion)
291 REAL(R8) :: fwmom(nion)
295 LOGICAL,
SAVE :: first = .true.
296 INTEGER :: return_status
297 TYPE (type_param
) :: code_parameters
305 fwcurr = 0.5_r8 * rho(nrho)
309 fwheat_el = 0.5_r8 * rho(nrho)
313 fwheat = 0.5_r8 * rho(nrho)
317 fwpart_el = 0.5_r8 * rho(nrho)
321 fwpart = 0.5_r8 * rho(nrho)
325 fwmom = 0.5_r8 * rho(nrho)
329 IF (return_status /= 0)
THEN
330 WRITE(*,*)
'ERROR: Could not assign source multipliers.'
338 IF (stot_el.NE.sum(stot*zion))
THEN
339 WRITE(*,*)
'=================================='
340 WRITE(*,*)
'=================================='
341 WRITE(*,*)
'== Your Gaussian sources are =='
342 WRITE(*,*)
'== not ambipolar! =='
343 WRITE(*,*)
'== This can break your worflow. =='
344 WRITE(*,*)
'=================================='
345 WRITE(*,*)
'=================================='
351 IF(jnitot .NE. 0.0_r8)
THEN
353 c = fwcurr/2.35482_r8
356 gfun = 1.0_r8 / (2.0_r8*itm_pi)**0.5/ c &
357 * exp(-(rho-a)**2 / 2.0_r8 / c**2) &
358 * vprime / 2.0_r8 / itm_pi / rho
360 IF (rho(1).EQ.0.0_r8) &
361 gfun(1) = 1.0_r8 / (2.0_r8*itm_pi)**0.5/ c &
362 * exp(-a**2 / 2.0_r8 / c**2) &
363 * 2.0_r8 * itm_pi * r0
365 CALL
integ(nrho, rho, gfun, intfun)
367 jni = 1.0_r8 / (2.0_r8*itm_pi)**0.5/ c &
368 * exp(-(rho-a)**2 / 2.0_r8 / c**2) &
377 IF(wtot_el .NE. 0.0_r8)
THEN
379 c = fwheat_el/2.35482_r8
382 gfun = 1.0_r8 / (2.0_r8*itm_pi)**0.5/ c &
383 * exp(-(rho-a)**2 / 2.0_r8 / c**2) &
386 CALL
integ(nrho, rho, gfun, intfun)
388 qel = 1.0_r8 / (2.0_r8*itm_pi)**0.5/ c &
389 * exp(-(rho-a)**2 / 2.0_r8 / c**2) &
400 IF(wtot(i) .NE. 0.0_r8)
THEN
402 c = fwheat(i)/2.35482_r8
405 gfun = 1.0_r8 / (2.0_r8*itm_pi)**0.5/ c &
406 * exp(-(rho-a)**2 / 2.0_r8 / c**2) &
409 CALL
integ(nrho, rho, gfun, intfun)
411 qion(:,i)= 1.0_r8 / (2.0_r8*itm_pi)**0.5/ c &
412 * exp(-(rho-a)**2 / 2.0_r8 / c**2) &
423 IF(stot_el .NE. 0.0)
THEN
425 c = fwpart_el/2.35482_r8
428 gfun = 1.0_r8 / (2.0_r8*itm_pi)**0.5/ c &
429 * exp(-(rho-a)**2 / 2.0_r8 / c**2) &
432 CALL
integ(nrho, rho, gfun, intfun)
434 sel = 1.0_r8 / (2.0_r8*itm_pi)**0.5/ c &
435 * exp(-(rho-a)**2 / 2.0_r8 / c**2) &
446 IF(stot(i) .NE. 0.0_r8)
THEN
448 c = fwpart(i)/2.35482_r8
451 gfun = 1.0_r8 / (2.0_r8*itm_pi)**0.5/ c &
452 * exp(-(rho-a)**2 / 2.0_r8 / c**2) &
455 CALL
integ(nrho, rho, gfun, intfun)
457 sion(:,i)= 1.0_r8 / (2.0_r8*itm_pi)**0.5/ c &
458 * exp(-(rho-a)**2 / 2.0_r8 / c**2) &
471 IF(rmom(i) .NE. 0.0)
THEN
473 c = fwmom(i)/2.35482_r8
476 gfun = 1.0_r8 / (2.0_r8*itm_pi)**0.5/ c &
477 * exp(-(rho-a)**2 / 2.0_r8 / c**2) &
480 CALL
integ(nrho, rho, gfun, intfun)
482 uion(:,i)= 1.0_r8 / (2.0_r8*itm_pi)**0.5/ c &
483 * exp(-(rho-a)**2 / 2.0_r8 / c**2) &
525 TYPE(type_param
) :: codeparameters
526 INTEGER(ITM_I4) :: return_status
528 TYPE(tree
) :: parameter_list
529 TYPE(element
),
POINTER :: temp_pointer
530 INTEGER(ITM_I4) :: i, nparm, n_values
531 CHARACTER(len = 132) :: cname
539 WRITE(6,*)
'Calling euitm_xml_parse'
540 CALL euitm_xml_parse(codeparameters, nparm, parameter_list)
541 WRITE(6,*)
'Called euitm_xml_parse'
545 temp_pointer => parameter_list%first
548 cname = char2str(temp_pointer%cname)
554 temp_pointer => temp_pointer%child
560 temp_pointer => temp_pointer%child
564 IF (
ALLOCATED(temp_pointer%cvalue)) &
565 CALL char2num(temp_pointer%cvalue, jnitot)
568 IF (
ALLOCATED(temp_pointer%cvalue)) &
569 CALL char2num(temp_pointer%cvalue, rcurr)
572 IF (
ALLOCATED(temp_pointer%cvalue)) &
573 CALL char2num(temp_pointer%cvalue, fwcurr)
580 temp_pointer => temp_pointer%child
585 temp_pointer => temp_pointer%child
589 IF (
ALLOCATED(temp_pointer%cvalue)) &
590 CALL char2num(temp_pointer%cvalue, wtot_el)
593 IF (
ALLOCATED(temp_pointer%cvalue)) &
594 CALL char2num(temp_pointer%cvalue, rheat_el)
597 IF (
ALLOCATED(temp_pointer%cvalue)) &
598 CALL char2num(temp_pointer%cvalue, fwheat_el)
603 CASE (
"particles_el")
604 temp_pointer => temp_pointer%child
608 IF (
ALLOCATED(temp_pointer%cvalue)) &
609 CALL char2num(temp_pointer%cvalue, stot_el)
612 IF (
ALLOCATED(temp_pointer%cvalue)) &
613 CALL char2num(temp_pointer%cvalue, rpart_el)
616 IF (
ALLOCATED(temp_pointer%cvalue)) &
617 CALL char2num(temp_pointer%cvalue, fwpart_el)
625 temp_pointer => temp_pointer%child
630 temp_pointer => temp_pointer%child
634 IF (
ALLOCATED(temp_pointer%cvalue)) &
635 CALL scan_str2real(char2str(temp_pointer%cvalue), amn, n_data)
638 IF (
ALLOCATED(temp_pointer%cvalue)) &
639 CALL scan_str2real(char2str(temp_pointer%cvalue), zn, n_data)
642 IF (
ALLOCATED(temp_pointer%cvalue)) &
643 CALL scan_str2real(char2str(temp_pointer%cvalue), zion, n_data)
648 temp_pointer => temp_pointer%child
652 IF (
ALLOCATED(temp_pointer%cvalue)) &
653 CALL scan_str2real(char2str(temp_pointer%cvalue), wtot, n_data)
656 IF (
ALLOCATED(temp_pointer%cvalue)) &
657 CALL scan_str2real(char2str(temp_pointer%cvalue), rheat, n_data)
660 IF (
ALLOCATED(temp_pointer%cvalue)) &
661 CALL scan_str2real(char2str(temp_pointer%cvalue), fwheat, n_data)
666 temp_pointer => temp_pointer%child
670 IF (
ALLOCATED(temp_pointer%cvalue)) &
671 CALL scan_str2real(char2str(temp_pointer%cvalue), stot, n_data)
674 IF (
ALLOCATED(temp_pointer%cvalue)) &
675 CALL scan_str2real(char2str(temp_pointer%cvalue), rpart, n_data)
678 IF (
ALLOCATED(temp_pointer%cvalue)) &
679 CALL scan_str2real(char2str(temp_pointer%cvalue), fwpart, n_data)
684 temp_pointer => temp_pointer%child
688 IF (
ALLOCATED(temp_pointer%cvalue)) &
689 CALL scan_str2real(char2str(temp_pointer%cvalue), utot, n_data)
692 IF (
ALLOCATED(temp_pointer%cvalue)) &
693 CALL scan_str2real(char2str(temp_pointer%cvalue), rmom, n_data)
696 IF (
ALLOCATED(temp_pointer%cvalue)) &
697 CALL scan_str2real(char2str(temp_pointer%cvalue), fwmom, n_data)
701 WRITE(*, *)
'ERROR: invalid parameter', cname
708 IF (
ASSOCIATED(temp_pointer%sibling))
THEN
709 temp_pointer => temp_pointer%sibling
712 IF (
ASSOCIATED(temp_pointer%parent, parameter_list%first )) &
714 IF (
ASSOCIATED(temp_pointer%parent))
THEN
715 temp_pointer => temp_pointer%parent
717 WRITE(*, *)
'ERROR: broken list.'
725 CALL destroy_xml_tree(parameter_list)
766 inty = inty + (y(i)+y(i-1))*(x(i)-x(i-1))/2.e0_r8
788 INTEGER :: i,ii,jj, ninput,nout
790 REAL (R8) :: rinput(ninput),finput(ninput)
792 REAL (R8) :: rout(nout),fout(nout)
793 REAL (R8) :: f(2),r,h1,h2,y1,y2,y3,a,b,c,z
798 IF(r.LE.rinput(2))
THEN
799 h1=rinput(2)-rinput(1)
800 h2=rinput(3)-rinput(2)
804 a=((y1-y2)*h2+(y3-y2)*h1)/h1/h2/(h1+h2)
805 b=((y3-y2)*h1*h1-(y1-y2)*h2*h2)/h1/h2/(h1+h2)
807 z=a*(r-rinput(2))**2+b*(r-rinput(2))+c
810 IF(r.GT.rinput(2).AND.r.LE.rinput(ninput-1))
THEN
812 IF(r.GT.rinput(ii-1).AND.r.LE.rinput(ii))
THEN
814 h1=rinput(ii-2+jj)-rinput(ii-3+jj)
815 h2=rinput(ii-1+jj)-rinput(ii-2+jj)
819 a=((y1-y2)*h2+(y3-y2)*h1)/h1/h2/(h1+h2)
820 b=((y3-y2)*h1*h1-(y1-y2)*h2*h2)/h1/h2/(h1+h2)
822 f(jj)=a*(r-rinput(ii-2+jj))**2+b*(r-rinput(ii-2+jj))+c
824 z=(f(1)*(rinput(ii)-r)+f(2)*(r-rinput(ii-1)))/ &
825 (rinput(ii)-rinput(ii-1))
830 IF(r.GE.rinput(ninput-1))
THEN
831 h1=rinput(ninput-1)-rinput(ninput-2)
832 h2=rinput(ninput)-rinput(ninput-1)
836 a=((y1-y2)*h2+(y3-y2)*h1)/h1/h2/(h1+h2)
837 b=((y3-y2)*h1*h1-(y1-y2)*h2*h2)/h1/h2/(h1+h2)
839 z=a*(r-rinput(ninput-1))**2+b*(r-rinput(ninput-1))+c
846 IF(rinput(1).EQ.rout(1))
THEN
847 IF(finput(1).NE.fout(1))
THEN
848 WRITE(*,*)
'INTERPOLATION corrected for ',rinput(1),finput(1),fout(1)
subroutine l3deriv(y_in, x_in, nr_in, dydx_out, x_out, nr_out)
subroutine additional_source(AMN, ZN, ZION, NRHO, RHO, R0, VPRIME, NION, QEL, QION, SEL, SION, UION, JNI, code_parameters)
subroutine get_comp_dimensions(COMPOSITIONS, NNUCL, NION, NIMP, NZIMP, NNEUT, NTYPE, NCOMP)
subroutine integ(N, X, Y, INTY)
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 assign_dummy_sources(codeparameters, return_status)
subroutine gausian_sources(COREPROF, EQUILIBRIUM, CORESOURCE, code_parameters)