6 SUBROUTINE bdseq (eq_in, eq_out, code_parameters)
27 TYPE (type_equilibrium
),
pointer :: eq_in(:), eq_out(:)
28 TYPE (type_param
) :: code_parameters
30 INTEGER(ITM_I4) :: npsi_eq
31 INTEGER(ITM_I4) :: iter
32 INTEGER(ITM_I4) :: i,j,ip,im
33 REAL(R8) :: a00,b00,r00,z00
34 REAL(R8) :: hra,heta,rho,dprime,det,coseta,sineta
35 REAL(R8) :: dpsi,pvol,parea,barea,iplasma
37 REAL(R8),
DIMENSION(:),
POINTER :: &
38 ra, eta, rtor, rvol,
pressure, jtor, jpar, ii, &
39 psi, phi, qq, volume, surface, area, vprime, aprime, ftrap
40 REAL(R8),
DIMENSION(:),
POINTER :: &
41 ffprime, pprime, dpsidr
42 REAL(R8),
DIMENSION(:),
POINTER :: &
43 gm1, gm2, gm3, gm4, gm5, gm6, gm7, gm8, gm9
44 REAL(R8),
DIMENSION(:,:),
POINTER :: rr, zz, &
45 g_11, g_12, g_22, g_13, g_23, g_33, bb2
46 REAL(R8),
DIMENSION(:),
POINTER :: dtdr,dtdn
47 REAL(R8),
DIMENSION(:,:),
POINTER :: theta,dtheta
51 integer(ITM_I4) :: return_status
53 character(len = 132),
target :: codename(1) =
'BDSEQ'
54 character(len = 132),
target :: codeversion(1) =
'7 Apr 2011'
60 CALL mpi_comm_size( mpi_comm_world, npes, ierr )
61 CALL mpi_comm_rank( mpi_comm_world, mype, ierr )
66 IF (.NOT.
ASSOCIATED(eq_out))
THEN
72 allocate(eq_out(1)%codeparam%codename(1))
73 allocate(eq_out(1)%codeparam%codeversion(1))
74 if (.not.
associated(code_parameters%parameters))
then
75 write(*,*)
'ERROR: BDSEQ parameters not associated!'
78 allocate(eq_out(1)%codeparam%parameters(
size( &
79 code_parameters%parameters)))
85 eq_out(1)%codeparam%codename = codename
86 eq_out(1)%codeparam%codeversion = codeversion
87 eq_out(1)%codeparam%parameters = code_parameters%parameters
92 if (return_status /= 0)
then
93 write(*,*)
'ERROR: Could not assign BDSEQ parameters.'
103 call open_write_file(12,
'EqIn' )
104 call write_cpo(eq_in(1),
'EqIn' )
105 call close_write_file
113 if(
associated(eq_in(1)%profiles_1d%rho_tor))
then
114 nr_eq =
size(eq_in(1)%profiles_1d%rho_tor)
115 write(*,*)
'nr_eq set on the basis of eq_in%profiles_1d%rho_tor to ', nr_eq
119 if(
associated(eq_in(1)%profiles_1d%psi))
then
120 nr_eq =
size(eq_in(1)%profiles_1d%psi)
121 write(*,*)
'nr_eq set on the basis of eq_in%profiles_1d%psi to ', nr_eq
124 IF (nr_eq == 0) nr_eq = 65
125 IF (neta_eq == 0)
then
126 if(
associated(eq_in(1)%coord_sys%position%R))
then
127 neta_eq =
SIZE (eq_in(1)%coord_sys%position%R, dim=2)
128 write(*,*)
'neta_eq set on the basis of eq_in%coord_sys%position%R to ', neta_eq
131 IF (neta_eq == 0) neta_eq = 256
136 allocate(eq_out(1)%profiles_1d%psi(nr_eq))
137 allocate(eq_out(1)%profiles_1d%phi(nr_eq))
138 allocate(eq_out(1)%profiles_1d%pressure(nr_eq))
139 allocate(eq_out(1)%profiles_1d%F_dia(nr_eq))
140 allocate(eq_out(1)%profiles_1d%pprime(nr_eq))
141 allocate(eq_out(1)%profiles_1d%ffprime(nr_eq))
142 allocate(eq_out(1)%profiles_1d%jphi(nr_eq))
143 allocate(eq_out(1)%profiles_1d%jparallel(nr_eq))
144 allocate(eq_out(1)%profiles_1d%q(nr_eq))
145 allocate(eq_out(1)%profiles_1d%r_inboard(nr_eq))
146 allocate(eq_out(1)%profiles_1d%r_outboard(nr_eq))
147 allocate(eq_out(1)%profiles_1d%rho_vol(nr_eq))
148 allocate(eq_out(1)%profiles_1d%rho_tor(nr_eq))
149 allocate(eq_out(1)%profiles_1d%elongation(nr_eq))
150 allocate(eq_out(1)%profiles_1d%tria_upper(nr_eq))
151 allocate(eq_out(1)%profiles_1d%tria_lower(nr_eq))
152 allocate(eq_out(1)%profiles_1d%volume(nr_eq))
153 allocate(eq_out(1)%profiles_1d%surface(nr_eq))
154 allocate(eq_out(1)%profiles_1d%area(nr_eq))
155 allocate(eq_out(1)%profiles_1d%vprime(nr_eq))
156 allocate(eq_out(1)%profiles_1d%aprime(nr_eq))
157 allocate(eq_out(1)%profiles_1d%dpsidrho_tor(nr_eq))
158 allocate(eq_out(1)%profiles_1d%gm1(nr_eq))
159 allocate(eq_out(1)%profiles_1d%gm2(nr_eq))
160 allocate(eq_out(1)%profiles_1d%gm3(nr_eq))
161 allocate(eq_out(1)%profiles_1d%gm4(nr_eq))
162 allocate(eq_out(1)%profiles_1d%gm5(nr_eq))
163 allocate(eq_out(1)%profiles_1d%gm6(nr_eq))
164 allocate(eq_out(1)%profiles_1d%gm7(nr_eq))
165 allocate(eq_out(1)%profiles_1d%gm8(nr_eq))
166 allocate(eq_out(1)%profiles_1d%gm9(nr_eq))
167 allocate(eq_out(1)%profiles_1d%ftrap(nr_eq))
168 allocate(eq_out(1)%profiles_1d%beta_pol(nr_eq))
169 allocate(eq_out(1)%profiles_1d%li(nr_eq))
170 allocate(eq_out(1)%profiles_1d%b_av(nr_eq))
171 allocate(eq_out(1)%profiles_1d%b_min(nr_eq))
172 allocate(eq_out(1)%profiles_1d%b_max(nr_eq))
173 allocate(eq_out(1)%profiles_1d%omega(nr_eq))
174 allocate(eq_out(1)%profiles_1d%omegaprime(nr_eq))
175 allocate(eq_out(1)%profiles_1d%mach_a(nr_eq))
176 allocate(eq_out(1)%profiles_1d%phi_flow(nr_eq))
177 allocate(eq_out(1)%profiles_1d%s_flow(nr_eq))
178 allocate(eq_out(1)%profiles_1d%h_flow(nr_eq))
180 allocate(eq_out(1)%eqgeometry%boundary(1))
181 allocate(eq_out(1)%eqgeometry%boundary(1)%r(neta_eq))
182 allocate(eq_out(1)%eqgeometry%boundary(1)%z(neta_eq))
184 allocate(eq_out(1)%coord_sys%position%r(nr_eq, neta_eq))
185 allocate(eq_out(1)%coord_sys%position%z(nr_eq, neta_eq))
186 allocate(eq_out(1)%coord_sys%g_11(nr_eq, neta_eq))
187 allocate(eq_out(1)%coord_sys%g_12(nr_eq, neta_eq))
188 allocate(eq_out(1)%coord_sys%g_22(nr_eq, neta_eq))
189 allocate(eq_out(1)%coord_sys%g_13(nr_eq, neta_eq))
190 allocate(eq_out(1)%coord_sys%g_23(nr_eq, neta_eq))
191 allocate(eq_out(1)%coord_sys%g_33(nr_eq, neta_eq))
192 allocate(eq_out(1)%coord_sys%jacobian(nr_eq, neta_eq))
193 allocate(eq_out(1)%coord_sys%grid%dim1(nr_eq))
194 allocate(eq_out(1)%coord_sys%grid%dim2(neta_eq))
195 allocate(eq_out(1)%coord_sys%grid_type(2))
197 IF (symmetry_coords)
THEN
198 eq_out(1)%coord_sys%grid_type(1) =
"symmetry coordinates"
199 eq_out(1)%coord_sys%grid_type(2) =
"same as straight field line coords"
201 eq_out(1)%coord_sys%grid_type(1) =
"shifted circle coordinates"
202 eq_out(1)%coord_sys%grid_type(2) = &
203 "output in these coordinates NOT in straight field line coords"
214 npsi_eq=
SIZE(eq_in(1)%profiles_1d%rho_tor)
222 a00=eq_in(1)%eqgeometry%a_minor
223 b00=eq_in(1)%global_param%toroid_field%b0
224 r00=eq_in(1)%global_param%toroid_field%r0
225 IF (itm_is_valid(eq_in(1)%eqgeometry%geom_axis%z))
THEN
226 z00=eq_in(1)%eqgeometry%geom_axis%z
231 eq_out(1)%eqgeometry%a_minor=a00
232 eq_out(1)%global_param%toroid_field%b0=b00
233 eq_out(1)%global_param%toroid_field%r0=r00
234 eq_out(1)%eqgeometry%geom_axis%r=r00
235 eq_out(1)%eqgeometry%geom_axis%z=z00
237 eq_out(1)%eqgeometry%elongation=1._r8
238 eq_out(1)%eqgeometry%tria_upper=0._r8
239 eq_out(1)%eqgeometry%tria_lower=0._r8
243 psi => eq_out(1)%profiles_1d%psi
244 phi => eq_out(1)%profiles_1d%phi
245 pressure => eq_out(1)%profiles_1d%pressure
246 ii => eq_out(1)%profiles_1d%F_dia
247 pprime => eq_out(1)%profiles_1d%pprime
248 ffprime => eq_out(1)%profiles_1d%ffprime
249 jtor => eq_out(1)%profiles_1d%jphi
250 jpar => eq_out(1)%profiles_1d%jparallel
251 qq => eq_out(1)%profiles_1d%q
253 ra => eq_out(1)%coord_sys%grid%dim1
254 eta => eq_out(1)%coord_sys%grid%dim2
256 rvol => eq_out(1)%profiles_1d%rho_vol
257 rtor => eq_out(1)%profiles_1d%rho_tor
258 volume => eq_out(1)%profiles_1d%volume
259 surface => eq_out(1)%profiles_1d%surface
260 area => eq_out(1)%profiles_1d%area
261 vprime => eq_out(1)%profiles_1d%vprime
262 aprime => eq_out(1)%profiles_1d%aprime
263 ftrap => eq_out(1)%profiles_1d%ftrap
265 gm1 => eq_out(1)%profiles_1d%gm1
266 gm2 => eq_out(1)%profiles_1d%gm2
267 gm3 => eq_out(1)%profiles_1d%gm3
268 gm4 => eq_out(1)%profiles_1d%gm4
269 gm5 => eq_out(1)%profiles_1d%gm5
270 gm6 => eq_out(1)%profiles_1d%gm6
271 gm7 => eq_out(1)%profiles_1d%gm7
272 gm8 => eq_out(1)%profiles_1d%gm8
273 gm9 => eq_out(1)%profiles_1d%gm9
275 rr => eq_out(1)%coord_sys%position%r
276 zz => eq_out(1)%coord_sys%position%z
277 g_11 => eq_out(1)%coord_sys%g_11
278 g_12 => eq_out(1)%coord_sys%g_12
279 g_22 => eq_out(1)%coord_sys%g_22
280 g_13 => eq_out(1)%coord_sys%g_13
281 g_23 => eq_out(1)%coord_sys%g_23
282 g_33 => eq_out(1)%coord_sys%g_33
284 dpsidr => eq_out(1)%profiles_1d%dpsidrho_tor
285 bb2 => eq_out(1)%coord_sys%g_23
293 ra = (/ (hra*(i-1),i=1,nr_eq) /)
296 eta = (/ (heta*(i-1),i=1,neta_eq) /)
306 IF (write_diags)
THEN
309 WRITE (0,*)
'rho_tor pressure current'
311 WRITE (0,
'(4g11.3)') &
312 eq_in(1)%profiles_1d%rho_tor(i), &
313 eq_in(1)%profiles_1d%pressure(i), &
314 eq_in(1)%profiles_1d%jphi(i)
322 CALL
l3interp( eq_in(1)%profiles_1d%pressure, &
323 eq_in(1)%profiles_1d%rho_tor, &
325 eq_out(1)%profiles_1d%pressure, &
326 eq_out(1)%profiles_1d%rho_tor, &
329 CALL
l3interp( eq_in(1)%profiles_1d%jphi, &
330 eq_in(1)%profiles_1d%rho_tor, &
332 eq_out(1)%profiles_1d%jphi, &
333 eq_out(1)%profiles_1d%rho_tor, &
338 IF (write_diags)
THEN
341 WRITE (0,*)
'ra rho_tor pressure current'
343 WRITE (0,
'(4g11.3)') eq_out(1)%profiles_1d%rho_vol(i), &
344 eq_out(1)%profiles_1d%rho_tor(i), &
345 eq_out(1)%profiles_1d%pressure(i), &
346 eq_out(1)%profiles_1d%jphi(i)
353 psi=jtor*r00*mu_0*(a00*a00)
359 qq(1)=2.*(psi(2)-psi(1))/(hra*hra)
361 qq(i)=(psi(i+1)-psi(i-1))/(2.*hra*ra(i))
364 qq(i)=2.*qq(i-1)-qq(i-2)
377 CALL
l3deriv(psi,ra,nr_eq,dpsidr,ra,nr_eq)
384 pprime=gm5/(dpsidr+1.e-30_r8)
389 ffprime = mu_0*r00*jtor/tpi - mu_0*r00*r00*pprime
393 ii=(r00*b00)*(r00*b00)/2.0_r8
395 ii(i)=ii(i+1) - 0.5*(ffprime(i)+ffprime(i+1))*(psi(i+1)-psi(i))
398 ii=sqrt(2.0_r8*ii)*sign(1.0_r8,b00)
407 gm1=(ra*ra/(2._r8*r00))
409 gm3=(2._r8*mu_0*r00*r00/(b00*b00))*ra*gm5 - gm4
412 gm2(i+1)=gm2(i)+0.5*(gm1(i+1)-gm1(i))*(gm3(i+1)+gm3(i))
421 gm1(i)=gm1(i+1)+0.5*(ra(i)-ra(i+1))*(gm2(i+1)+gm2(i))
424 eq_out(1)%profiles_1d%r_inboard=r00-ra + gm1
425 eq_out(1)%profiles_1d%r_outboard=r00+ra + gm1
426 eq_out(1)%profiles_1d%elongation=1._r8
427 eq_out(1)%profiles_1d%tria_upper=0._r8
428 eq_out(1)%profiles_1d%tria_lower=0._r8
432 eq_out(1)%global_param%mag_axis%position%r = r00 + gm1(1)
433 eq_out(1)%global_param%mag_axis%position%z = z00
434 eq_out(1)%global_param%mag_axis%q = qq(1)
435 eq_out(1)%global_param%mag_axis%bphi = ii(1)/(r00 + gm1(1))
446 rr(:,j)=r00+ra*coseta + gm1
447 zz(:,j)=z00+ra*sineta
449 eq_out(1)%eqgeometry%boundary(1)%r(j)=r00+a00*coseta
450 eq_out(1)%eqgeometry%boundary(1)%z(j)=z00+a00*sineta
456 det=(1.+dprime*coseta)**(-2.0)
459 g_12(i,j)=det*dprime*sineta
460 g_22(i,j)=det*(1.+2.*dprime*coseta+dprime*dprime)
462 g_33(i,j)=rr(i,j)*(1.+dprime*coseta)
466 g_12(:,j)=g_12(:,j)/(ra+1e-30_r8)
467 g_22(:,j)=g_22(:,j)/((ra+1e-30_r8)*(ra+1e-30_r8))
471 IF (symmetry_coords)
THEN
476 gm9=1./sum(g_33, dim=2)
478 dtheta(:,j)=tpi*g_33(:,j)*gm9
482 theta(:,j)=theta(:,j-1)+(dtheta(:,j)+dtheta(:,j-1))/2.
485 ALLOCATE(dtdn(neta_eq))
486 ALLOCATE(dtdr(neta_eq))
494 dtdn=dtheta(i,:)/heta
495 dtdr=(theta(ip,:)-theta(im,:))/(ra(ip)-ra(im))
497 g_22(i,:)=(dtdr*dtdr*g_11(i,:)+2.0_r8*dtdr*dtdn*g_12(i,:) &
498 +dtdn*dtdn*g_22(i,:))
499 g_12(i,:)=(dtdr*g_11(i,:)+dtdn*g_12(i,:))
501 CALL
l3interp2( g_11(i,:), theta(i,:), eta, neta_eq )
502 CALL
l3interp2( g_12(i,:), theta(i,:), eta, neta_eq )
503 CALL
l3interp2( g_22(i,:), theta(i,:), eta, neta_eq )
504 CALL
l3interp2( g_33(i,:), theta(i,:), eta, neta_eq )
505 CALL
l3interp2( rr(i,:), theta(i,:), eta, neta_eq )
506 CALL
l3interp2( zz(i,:), theta(i,:), eta, neta_eq )
517 bb2(:,j)=ii*ii+dpsidr*dpsidr*g_11(:,j)/(tpi*tpi)
521 gm9=1./sum(g_33, dim=2)
523 gm1=sum(g_33/(rr*rr), dim=2) * gm9
524 gm2=sum(g_33*g_11/(rr*rr), dim=2) * gm9
525 gm3=sum(g_33*g_11, dim=2) * gm9
526 gm4=sum(g_33/bb2, dim=2) * gm9
527 gm5=sum(g_33*bb2, dim=2) * gm9
528 gm6=sum(g_33*g_11/bb2, dim=2) * gm9
529 gm7=sum(g_33*sqrt(g_11), dim=2) * gm9
530 gm8=sum(g_33*rr, dim=2) * gm9
533 eq_out(1)%profiles_1d%b_av=sum(g_33*bb2, dim=2) * gm9
535 gm9=sum(g_33/rr, dim=2) * gm9
538 eq_out(1)%profiles_1d%b_min(i)=minval(bb2(i,:))
539 eq_out(1)%profiles_1d%b_max(i)=maxval(bb2(i,:))
543 g_11(:,j)=g_11(:,j)*dpsidr*dpsidr
544 g_12(:,j)=g_12(:,j)*dpsidr
551 eq_out(1)%coord_sys%jacobian=sqrt( (g_11*g_22-g_12*g_12)*g_33 )
556 surface=tpi*tpi*r00*ra
558 volume=tpi*pi*ra*ra*r00
560 CALL
l3deriv(volume,psi,nr_eq,vprime,psi,nr_eq)
561 CALL
l3deriv(area,psi,nr_eq,aprime,psi,nr_eq)
566 ftrap=1._r8 - ((1._r8-ftrap)**2._r8) &
567 /( sqrt((1._r8-ftrap)**2._r8)*(1._r8+1.46_r8*sqrt(ftrap)) )
571 eq_out(1)%profiles_1d%omega=0.
572 eq_out(1)%profiles_1d%omegaprime=0.
573 eq_out(1)%profiles_1d%mach_a=0.
574 eq_out(1)%profiles_1d%phi_flow=0.
575 eq_out(1)%profiles_1d%s_flow=0.
576 eq_out(1)%profiles_1d%h_flow=0.
581 eq_out(1)%global_param%volume = tpi*pi*r00*a00*a00
582 eq_out(1)%global_param%area = pi*a00*a00
583 eq_out(1)%global_param%psi_ax = psi(1)
584 eq_out(1)%global_param%psi_bound = psi(nr_eq)
585 eq_out(1)%global_param%q_95 = qq(nr_eq)
586 eq_out(1)%global_param%q_min = minval(abs(qq))*sign(1.0_r8,qq(nr_eq))
596 hra=volume(i+1)-volume(i)
598 hra=area(i+1)-area(i)
600 iplasma=iplasma+0.5_r8*hra*(jtor(i+1)+jtor(i))
601 dpsi=(ra(i+1)+ra(i))/(qq(i+1)+qq(i))
602 barea=barea+hra*dpsi*dpsi
604 pvol=pvol/eq_out(1)%global_param%volume
605 barea=barea/eq_out(1)%global_param%area
607 eq_out(1)%global_param%i_plasma = iplasma
608 eq_out(1)%global_param%beta_tor = pvol*2.0_r8*mu_0/(b00*b00)
609 eq_out(1)%global_param%beta_pol = 8.0_r8*pi*parea/(mu_0*iplasma*iplasma)
610 eq_out(1)%global_param%li = barea*qq(nr_eq)*qq(nr_eq)/(a00*a00)
612 eq_out(1)%global_param%beta_normal = &
613 eq_out(1)%global_param%beta_tor*a00*abs(b00/(iplasma*1.e-6_r8))
617 eq_out(1)%time=eq_in(1)%time
623 call open_write_file(12,
'EqOut' )
624 call write_cpo(eq_out(1),
'EqOut' )
625 call close_write_file
642 INTEGER(ITM_I4) :: nr
643 REAL(R8),
DIMENSION(nr) :: u2
645 INTEGER(ITM_I4) :: i,im
646 REAL(R8),
DIMENSION(:),
ALLOCATABLE :: a2,d2,c2
648 LOGICAL,
SAVE :: first_flag = .true.
652 ALLOCATE (a2(nr),d2(nr),c2(nr))
656 u2=u2/
REAL((nr-1)*(nr-1))
659 c2(i)=-1._r8-1./(2._r8*
REAL(i-1))
660 a2(i)=-1._r8+1./(2._r8*
REAL(i-1))
669 d2(i)=1./(d2(i)-a2(i)*c2(im))
671 u2(i)=(u2(i)-a2(i)*u2(im))*d2(i)
677 u2(i)=u2(i)-c2(i)*u2(i+1)
694 INTEGER(ITM_I4) :: neta
695 REAL(R8),
DIMENSION(neta),
INTENT(IN) :: x_in,x_out
696 REAL(R8),
DIMENSION(neta),
INTENT(INOUT) :: y_out
698 REAL(R8),
DIMENSION(:),
ALLOCATABLE :: y_in
700 REAL(R8) :: x,aintm,aint0,aint1,aint2,xm,x0,x1,x2
701 INTEGER(ITM_I4) :: j,jm,j0,j1,j2
709 DO WHILE (x >= x_in(j1) .AND. j1 < neta)
712 IF (j1 == neta .AND. x >= x_in(neta)) j1=j1+1
720 IF (jm < 1) jm=jm+neta
721 IF (j0 < 1) j0=j0+neta
722 IF (j1 > neta) j1=j1-neta
723 IF (j2 > neta) j2=j2-neta
734 IF (xm < 0.0_r8) xm=xm+tpi
735 IF (x0 < 0.0_r8) x0=x0+tpi
736 IF (x1 > tpi) x1=x1-tpi
737 IF (x2 > tpi) x2=x2-tpi
741 aintm=(x-x0)*(x-x1)*(x-x2)/((xm-x0)*(xm-x1)*(xm-x2))
742 aint0=(x-xm)*(x-x1)*(x-x2)/((x0-xm)*(x0-x1)*(x0-x2))
743 aint1=(x-xm)*(x-x0)*(x-x2)/((x1-xm)*(x1-x0)*(x1-x2))
744 aint2=(x-xm)*(x-x0)*(x-x1)/((x2-xm)*(x2-x0)*(x2-x1))
746 y_out(j)=aintm*y_in(jm)+aint0*y_in(j0) &
747 +aint1*y_in(j1)+aint2*y_in(j2)
subroutine l3deriv(y_in, x_in, nr_in, dydx_out, x_out, nr_out)
subroutine trid(u2, nr)
Tridiagonal solve.
subroutine bdseq(eq_in, eq_out, code_parameters)
Module implementing a simple equilibrium using CPOs.
subroutine assign_equil_parameters(code_parameters, return_status)
subroutine l3interp2(y_out, x_in, x_out, neta)
periodic interpolation on second dimension
subroutine l3interp(y_in, x_in, nr_in, y_out, x_out, nr_out)
real(r8) function pressure(flux)