ETS  \$Id: Doxyfile 2162 2020-02-26 14:16:09Z g2dpc $
 All Classes Files Functions Variables Pages
bdseq_integrals.F90
Go to the documentation of this file.
1 
6 SUBROUTINE bdseq (eq_in, eq_out, code_parameters)
7 
8 !... simple 1D equilibrium module, a set of integrals
9 !... eq_in is set up by top level subroutine plasma_equil
10 !... for now the input xml files are read and processed herein
11 
12 !... on output all the 1d profiles are filled plus
13 !... the minimal 2d profiles needed by a fluxtube turbulence code
14 !... pi and tpi and mu_0 and the ITM_I4/R8 are defined in
15 !... Phys_Constants which calls ITM_Types
16 
17 #ifdef MPI
18  USE mpes
19 #endif
20  USE phys_constants
21  USE euitm_schemas
22  USE bdseq_coeff
23  USE write_structures
24 
25  IMPLICIT NONE
26 
27  TYPE (type_equilibrium), pointer :: eq_in(:), eq_out(:)
28  TYPE (type_param) :: code_parameters
29 
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,vva
35  REAL(R8) :: dpsi,pvol,parea,barea,iplasma
36 
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
48 
49 !... XML declarations
50 
51  integer(ITM_I4) :: return_status
52 
53  character(len = 132), target :: codename(1) = 'BDSEQ'
54  character(len = 132), target :: codeversion(1) = '7 Apr 2011'
55 
56 !... if running MPI you need these
57 
58 #ifdef MPI
59  INTEGER :: mype,npes
60  CALL mpi_comm_size( mpi_comm_world, npes, ierr )
61  CALL mpi_comm_rank( mpi_comm_world, mype, ierr )
62 #endif
63 
64 !... allocations
65 
66  IF (.NOT. ASSOCIATED(eq_out)) THEN
67 
68 !... assign parms
69 
70  allocate(eq_out(1))
71  allocate(eq_out(1)%codeparam%codename(1))
72  allocate(eq_out(1)%codeparam%codeversion(1))
73  if (.not. associated(code_parameters%parameters)) then
74  write(*,*) 'ERROR: BDSEQ parameters not associated!'
75  stop
76  else
77  allocate(eq_out(1)%codeparam%parameters(size( &
78  code_parameters%parameters)))
79  end if
80 
81 !. write(*,*) 'BDSEQ Parameters : ', code_parameters%parameters
82 
83 !-- add to eq_out
84  eq_out(1)%codeparam%codename = codename
85  eq_out(1)%codeparam%codeversion = codeversion
86  eq_out(1)%codeparam%parameters = code_parameters%parameters
87 
88 !-- assign code parameters to internal variables
89  call assign_equil_parameters(code_parameters, return_status)
90 
91  if (return_status /= 0) then
92  write(*,*) 'ERROR: Could not assign BDSEQ parameters.'
93  return
94  end if
95 
96 !. write(*,*) 'done assigning BDSEQ parameters'
97 
98 !... write out input cpos
99 
100  IF (write_cpos) THEN
101 
102  call open_write_file(12, 'EqIn' )
103  call write_cpo(eq_in(1), 'EqIn' )
104  call close_write_file
105 
106  END IF
107 
108 !... set grid size for equilibrium calculation and output
109 !... idiot protection
110 
111  IF (nr_eq == 0) nr_eq = 65
112  IF (neta_eq == 0) neta_eq = 256
113 
114 !... do all the calculations on the output structure
115 !... fill all the 1d profiles
116 
117  allocate(eq_out(1)%profiles_1d%psi(nr_eq))
118  allocate(eq_out(1)%profiles_1d%phi(nr_eq))
119  allocate(eq_out(1)%profiles_1d%pressure(nr_eq))
120  allocate(eq_out(1)%profiles_1d%F_dia(nr_eq))
121  allocate(eq_out(1)%profiles_1d%pprime(nr_eq))
122  allocate(eq_out(1)%profiles_1d%ffprime(nr_eq))
123  allocate(eq_out(1)%profiles_1d%jphi(nr_eq))
124  allocate(eq_out(1)%profiles_1d%jparallel(nr_eq))
125  allocate(eq_out(1)%profiles_1d%q(nr_eq))
126  allocate(eq_out(1)%profiles_1d%r_inboard(nr_eq))
127  allocate(eq_out(1)%profiles_1d%r_outboard(nr_eq))
128  allocate(eq_out(1)%profiles_1d%rho_vol(nr_eq))
129  allocate(eq_out(1)%profiles_1d%rho_tor(nr_eq))
130  allocate(eq_out(1)%profiles_1d%elongation(nr_eq))
131  allocate(eq_out(1)%profiles_1d%tria_upper(nr_eq))
132  allocate(eq_out(1)%profiles_1d%tria_lower(nr_eq))
133  allocate(eq_out(1)%profiles_1d%volume(nr_eq))
134  allocate(eq_out(1)%profiles_1d%surface(nr_eq))
135  allocate(eq_out(1)%profiles_1d%area(nr_eq))
136  allocate(eq_out(1)%profiles_1d%vprime(nr_eq))
137  allocate(eq_out(1)%profiles_1d%aprime(nr_eq))
138  allocate(eq_out(1)%profiles_1d%dpsidrho_tor(nr_eq))
139  allocate(eq_out(1)%profiles_1d%gm1(nr_eq))
140  allocate(eq_out(1)%profiles_1d%gm2(nr_eq))
141  allocate(eq_out(1)%profiles_1d%gm3(nr_eq))
142  allocate(eq_out(1)%profiles_1d%gm4(nr_eq))
143  allocate(eq_out(1)%profiles_1d%gm5(nr_eq))
144  allocate(eq_out(1)%profiles_1d%gm6(nr_eq))
145  allocate(eq_out(1)%profiles_1d%gm7(nr_eq))
146  allocate(eq_out(1)%profiles_1d%gm8(nr_eq))
147  allocate(eq_out(1)%profiles_1d%gm9(nr_eq))
148  allocate(eq_out(1)%profiles_1d%ftrap(nr_eq))
149  allocate(eq_out(1)%profiles_1d%beta_pol(nr_eq))
150  allocate(eq_out(1)%profiles_1d%li(nr_eq))
151  allocate(eq_out(1)%profiles_1d%b_av(nr_eq))
152  allocate(eq_out(1)%profiles_1d%b_min(nr_eq))
153  allocate(eq_out(1)%profiles_1d%b_max(nr_eq))
154  allocate(eq_out(1)%profiles_1d%omega(nr_eq))
155  allocate(eq_out(1)%profiles_1d%omegaprime(nr_eq))
156  allocate(eq_out(1)%profiles_1d%mach_a(nr_eq))
157  allocate(eq_out(1)%profiles_1d%phi_flow(nr_eq))
158  allocate(eq_out(1)%profiles_1d%s_flow(nr_eq))
159  allocate(eq_out(1)%profiles_1d%h_flow(nr_eq))
160 
161  allocate(eq_out(1)%eqgeometry%boundary(1))
162  allocate(eq_out(1)%eqgeometry%boundary(1)%r(neta_eq))
163  allocate(eq_out(1)%eqgeometry%boundary(1)%z(neta_eq))
164 
165  allocate(eq_out(1)%coord_sys%position%r(nr_eq, neta_eq))
166  allocate(eq_out(1)%coord_sys%position%z(nr_eq, neta_eq))
167  allocate(eq_out(1)%coord_sys%g_11(nr_eq, neta_eq))
168  allocate(eq_out(1)%coord_sys%g_12(nr_eq, neta_eq))
169  allocate(eq_out(1)%coord_sys%g_22(nr_eq, neta_eq))
170  allocate(eq_out(1)%coord_sys%g_13(nr_eq, neta_eq))
171  allocate(eq_out(1)%coord_sys%g_23(nr_eq, neta_eq))
172  allocate(eq_out(1)%coord_sys%g_33(nr_eq, neta_eq))
173  allocate(eq_out(1)%coord_sys%jacobian(nr_eq, neta_eq))
174  allocate(eq_out(1)%coord_sys%grid%dim1(nr_eq))
175  allocate(eq_out(1)%coord_sys%grid%dim2(neta_eq))
176  allocate(eq_out(1)%coord_sys%grid_type(2))
177 
178  IF (symmetry_coords) THEN
179  eq_out(1)%coord_sys%grid_type(1) = "symmetry coordinates"
180  eq_out(1)%coord_sys%grid_type(2) = "same as straight field line coords"
181  ELSE
182  eq_out(1)%coord_sys%grid_type(1) = "shifted circle coordinates"
183  eq_out(1)%coord_sys%grid_type(2) = &
184  "output in these coordinates NOT in straight field line coords"
185  END IF
186 
187 !... done initialisation
188 
189  END IF
190 
191 !... this is a zero-epsilon model, no distinction between jtor and jpar
192 !... jtor is called jphi in this CPO and jpar is called jparallel
193 
194 !... find grid size for equilibrium input
195 
196  npsi_eq=SIZE(eq_in(1)%profiles_1d%rho_tor)
197 
198 !... get the global parameters
199 !... the convention on a00 is that it is the maximum value of
200 !... rho_tor not the reference machine minor radius!
201 !... for the purposes of this code, a00 is in fact whatever you loaded
202 !... into eq_in a_minor
203 
204  a00=eq_in(1)%eqgeometry%a_minor
205  b00=eq_in(1)%global_param%toroid_field%b0
206  r00=eq_in(1)%global_param%toroid_field%r0
207  IF (itm_is_valid(eq_in(1)%eqgeometry%geom_axis%z)) THEN
208  z00=eq_in(1)%eqgeometry%geom_axis%z
209  ELSE
210  z00 = 0.0_r8
211  END IF
212 
213  eq_out(1)%eqgeometry%a_minor=a00
214  eq_out(1)%global_param%toroid_field%b0=b00
215  eq_out(1)%global_param%toroid_field%r0=r00
216  eq_out(1)%eqgeometry%geom_axis%r=r00
217  eq_out(1)%eqgeometry%geom_axis%z=z00
218 
219  eq_out(1)%eqgeometry%elongation=1._r8
220  eq_out(1)%eqgeometry%tria_upper=0._r8
221  eq_out(1)%eqgeometry%tria_lower=0._r8
222 
223 !... associations
224 
225  psi => eq_out(1)%profiles_1d%psi
226  phi => eq_out(1)%profiles_1d%phi
227  pressure => eq_out(1)%profiles_1d%pressure
228  ii => eq_out(1)%profiles_1d%F_dia
229  pprime => eq_out(1)%profiles_1d%pprime
230  ffprime => eq_out(1)%profiles_1d%ffprime
231  jtor => eq_out(1)%profiles_1d%jphi
232  jpar => eq_out(1)%profiles_1d%jparallel
233  qq => eq_out(1)%profiles_1d%q
234 
235  ra => eq_out(1)%coord_sys%grid%dim1
236  eta => eq_out(1)%coord_sys%grid%dim2
237 
238  rvol => eq_out(1)%profiles_1d%rho_vol
239  rtor => eq_out(1)%profiles_1d%rho_tor
240  volume => eq_out(1)%profiles_1d%volume
241  surface => eq_out(1)%profiles_1d%surface
242  area => eq_out(1)%profiles_1d%area
243  vprime => eq_out(1)%profiles_1d%vprime
244  aprime => eq_out(1)%profiles_1d%aprime
245  ftrap => eq_out(1)%profiles_1d%ftrap
246 
247  gm1 => eq_out(1)%profiles_1d%gm1
248  gm2 => eq_out(1)%profiles_1d%gm2
249  gm3 => eq_out(1)%profiles_1d%gm3
250  gm4 => eq_out(1)%profiles_1d%gm4
251  gm5 => eq_out(1)%profiles_1d%gm5
252  gm6 => eq_out(1)%profiles_1d%gm6
253  gm7 => eq_out(1)%profiles_1d%gm7
254  gm8 => eq_out(1)%profiles_1d%gm8
255  gm9 => eq_out(1)%profiles_1d%gm9
256 
257  rr => eq_out(1)%coord_sys%position%r
258  zz => eq_out(1)%coord_sys%position%z
259  g_11 => eq_out(1)%coord_sys%g_11
260  g_12 => eq_out(1)%coord_sys%g_12
261  g_22 => eq_out(1)%coord_sys%g_22
262  g_13 => eq_out(1)%coord_sys%g_13
263  g_23 => eq_out(1)%coord_sys%g_23
264  g_33 => eq_out(1)%coord_sys%g_33
265 
266  dpsidr => eq_out(1)%profiles_1d%dpsidrho_tor
267  bb2 => eq_out(1)%coord_sys%g_23
268 
269 !... on input, rho_tor, p and J
270 !... equidistant grid in geometric r which is rho_vol
271 !... here rho_vol and rho_tor_norm are assumed to be equivalent
272 !... consistent with I = R_0 B_0
273 
274  hra=1.0_r8/(nr_eq-1)
275  ra = (/ (hra*(i-1),i=1,nr_eq) /)
276 
277  heta=tpi/(neta_eq)
278  eta = (/ (heta*(i-1),i=1,neta_eq) /)
279 
280  rvol = ra
281  rtor = ra*a00
282 
283  hra=a00/(nr_eq-1)
284  ra => rtor
285 
286  volume=tpi*pi*ra*ra*r00
287  vva=tpi*pi*r00*a00*a00
288 
289 !... check profiles
290 
291  IF (write_diags) THEN
292 
293  WRITE (0,*) 'input'
294  WRITE (0,*) 'rho_tor pressure current'
295  DO i=1,npsi_eq
296  WRITE (0,'(4g11.3)') &
297  eq_in(1)%profiles_1d%rho_tor(i), &
298  eq_in(1)%profiles_1d%pressure(i), &
299  eq_in(1)%profiles_1d%jphi(i)
300  END DO
301 
302  END IF
303 
304 !... interpolate p and J onto the final grid
305 !... use jpar and jtor interchangeably
306 
307  CALL l3interp( eq_in(1)%profiles_1d%pressure, &
308  eq_in(1)%profiles_1d%rho_tor, &
309  npsi_eq, &
310  eq_out(1)%profiles_1d%pressure, &
311  eq_out(1)%profiles_1d%rho_tor, &
312  nr_eq )
313 
314  CALL l3interp( eq_in(1)%profiles_1d%jphi, &
315  eq_in(1)%profiles_1d%rho_tor, &
316  npsi_eq, &
317  eq_out(1)%profiles_1d%jphi, &
318  eq_out(1)%profiles_1d%rho_tor, &
319  nr_eq )
320 
321  jpar=jtor
322 
323  IF (write_diags) THEN
324 
325  WRITE (0,*) 'output'
326  WRITE (0,*) 'ra rho_tor pressure current'
327  DO i=1,nr_eq
328  WRITE (0,'(4g11.3)') eq_out(1)%profiles_1d%rho_vol(i), &
329  eq_out(1)%profiles_1d%rho_tor(i), &
330  eq_out(1)%profiles_1d%pressure(i), &
331  eq_out(1)%profiles_1d%jphi(i)
332  END DO
333 
334  END IF
335 
336 !... do the integrals using the gm? as scratch space
337 
338 !... find the pitch parameter from the current profile
339 
340  gm1= - (mu_0*r00/(2._r8*b00))*jtor
341 
342  qq(1)=0._r8
343  DO i=1,nr_eq-1
344  qq(i+1)=qq(i)+0.5*(gm1(i)+gm1(i+1))*(volume(i+1)-volume(i))
345  END DO
346  qq(1)=1._r8
347  qq=volume/qq
348  qq(1) = - 2._r8*b00/(mu_0*r00*jtor(1))
349 
350 !... find the toroidal flux
351 
352  phi=(pi*b00*a00*a00/vva)*volume
353 
354 !... find the poloidal flux
355 
356  psi(1)=0._r8
357  gm1=1._r8/qq
358  DO i=1,nr_eq-1
359  psi(i+1)=psi(i)+0.5*(gm1(i)+gm1(i+1))*(phi(i+1)-phi(i))
360  END DO
361 
362 !... dpsidr is now used for dPsi/drho which normalises the metric
363 
364  CALL l3deriv(psi,ra,nr_eq,dpsidr,ra,nr_eq)
365  dpsidr(1)=0._r8
366 
367 !... find the Grad-Shafranov equation quantities
368 !... hold dpdrho in gm5
369 
370  CALL l3deriv(pressure,ra,nr_eq,gm5,ra,nr_eq)
371  pprime=gm5/(dpsidr+1.e-30_r8)
372  pprime(1)=(pressure(2)-pressure(1))/(psi(2)-psi(1))
373 
374 ! CALL L3deriv(pressure,psi,nr_eq,pprime,psi,nr_eq)
375 
376  ffprime = mu_0*r00*jtor/tpi - mu_0*r00*r00*pprime
377 
378 !... set the diamagnetic compression
379 
380  ii=(r00*b00)*(r00*b00)/2.0_r8
381  DO i=nr_eq-1,1,-1
382  ii(i)=ii(i+1) - 0.5*(ffprime(i)+ffprime(i+1))*(psi(i+1)-psi(i))
383  END DO
384 
385  ii=sqrt(2.0_r8*ii)*sign(1.0_r8,b00)
386 
387 !... flux surface shape and shifts
388 !... here use gm1 for delta
389 !... gm2 for delta prime
390 !... gm3 for integrand for delta prime
391 !... gm4 for r^2/q^2
392 !... gm5 for dp/dr
393 
394  gm1=(ra*ra/(2._r8*r00))
395  gm4=(ra/qq)**2.
396  gm3=(2._r8*mu_0*r00*r00/(b00*b00))*ra*gm5 - gm4
397  gm2(1)=0._r8
398  DO i=1,nr_eq-1
399  gm2(i+1)=gm2(i)+0.5*(gm1(i+1)-gm1(i))*(gm3(i+1)+gm3(i))
400  END DO
401  gm4=gm4*ra
402  gm4(1)=1._r8
403  gm2=gm2/gm4
404  gm2(1)=0._r8
405 
406  gm1(nr_eq)=0._r8
407  DO i=nr_eq-1,1,-1
408  gm1(i)=gm1(i+1)+0.5*(ra(i)-ra(i+1))*(gm2(i+1)+gm2(i))
409  END DO
410 
411  eq_out(1)%profiles_1d%r_inboard=r00-ra + gm1
412  eq_out(1)%profiles_1d%r_outboard=r00+ra + gm1
413  eq_out(1)%profiles_1d%elongation=1._r8
414  eq_out(1)%profiles_1d%tria_upper=0._r8
415  eq_out(1)%profiles_1d%tria_lower=0._r8
416 
417 !... set axis parameters here since we still have delta in gm1
418 
419  eq_out(1)%global_param%mag_axis%position%r = r00 + gm1(1)
420  eq_out(1)%global_param%mag_axis%position%z = z00
421  eq_out(1)%global_param%mag_axis%q = qq(1)
422  eq_out(1)%global_param%mag_axis%bphi = ii(1)/(r00 + gm1(1))
423 
424 !... find the quantities needed by the other modules
425 !... eg these are the quantities GEM needs from HELENA
426 !... gm1 still contains the shifts
427 !... gm2 still contains the derivatives of the shifts
428 
429  DO j=1,neta_eq
430  sineta=sin(eta(j))
431  coseta=cos(eta(j))
432 
433  rr(:,j)=r00+ra*coseta + gm1
434  zz(:,j)=z00+ra*sineta
435 
436  eq_out(1)%eqgeometry%boundary(1)%r(j)=r00+a00*coseta
437  eq_out(1)%eqgeometry%boundary(1)%z(j)=z00+a00*sineta
438 
439  DO i=1,nr_eq
440  rho=ra(i)
441  dprime=gm2(i)
442 
443  det=(1.+dprime*coseta)**(-2.0)
444 
445  g_11(i,j)=det
446  g_12(i,j)=det*dprime*sineta
447  g_22(i,j)=det*(1.+2.*dprime*coseta+dprime*dprime)
448 
449  g_33(i,j)=rr(i,j)*(1.+dprime*coseta)
450 
451  END DO
452 
453  g_12(:,j)=g_12(:,j)/ra
454  g_22(:,j)=g_22(:,j)/(ra*ra)
455 
456  END DO
457 
458  IF (symmetry_coords) THEN
459  dtheta => g_13
460  theta => g_23
461 
462  g_33=g_33/(rr*rr)
463  gm9=1./sum(g_33, dim=2)
464  DO j=1,neta_eq
465  dtheta(:,j)=tpi*g_33(:,j)*gm9
466  END DO
467  theta(:,1)=0.0_r8
468  DO j=2,neta_eq
469  theta(:,j)=theta(:,j-1)+(dtheta(:,j)+dtheta(:,j-1))/2.
470  END DO
471 
472  ALLOCATE(dtdn(neta_eq))
473  ALLOCATE(dtdr(neta_eq))
474 
475  DO i=1,nr_eq
476  ip=i+1
477  im=i-1
478  IF (i == 1) im=i
479  IF (i == nr_eq) ip=i
480 
481  dtdn=dtheta(i,:)/heta
482  dtdr=(theta(ip,:)-theta(im,:))/(ra(ip)-ra(im))
483 
484  g_22(i,:)=(dtdr*dtdr*g_11(i,:)+2.0_r8*dtdr*dtdn*g_12(i,:) &
485  +dtdn*dtdn*g_22(i,:))
486  g_12(i,:)=(dtdr*g_11(i,:)+dtdn*g_12(i,:))
487 
488  CALL l3interp2( g_11(i,:), theta(i,:), eta, neta_eq )
489  CALL l3interp2( g_12(i,:), theta(i,:), eta, neta_eq )
490  CALL l3interp2( g_22(i,:), theta(i,:), eta, neta_eq )
491  CALL l3interp2( g_33(i,:), theta(i,:), eta, neta_eq )
492  CALL l3interp2( rr(i,:), theta(i,:), eta, neta_eq )
493  CALL l3interp2( zz(i,:), theta(i,:), eta, neta_eq )
494  END DO
495 
496  g_33=rr*rr
497 
498  DEALLOCATE(dtdn)
499  DEALLOCATE(dtdr)
500 
501  END IF
502 
503  DO j=1,neta_eq
504  bb2(:,j)=ii*ii+dpsidr*dpsidr*g_11(:,j)/(tpi*tpi)
505  END DO
506  bb2=bb2/(rr*rr)
507 
508  gm9=1./sum(g_33, dim=2)
509 
510  gm1=sum(g_33/(rr*rr), dim=2) * gm9
511  gm2=sum(g_33*g_11/(rr*rr), dim=2) * gm9
512  gm3=sum(g_33*g_11, dim=2) * gm9
513  gm4=sum(g_33/bb2, dim=2) * gm9
514  gm5=sum(g_33*bb2, dim=2) * gm9
515  gm6=sum(g_33*g_11/bb2, dim=2) * gm9
516  gm7=sum(g_33*sqrt(g_11), dim=2) * gm9
517  gm8=sum(g_33*rr, dim=2) * gm9
518 
519  bb2=sqrt(bb2)
520  eq_out(1)%profiles_1d%b_av=sum(g_33*bb2, dim=2) * gm9
521 
522  gm9=sum(g_33/rr, dim=2) * gm9
523 
524  DO i=1,nr_eq
525  eq_out(1)%profiles_1d%b_min(i)=minval(bb2(i,:))
526  eq_out(1)%profiles_1d%b_max(i)=maxval(bb2(i,:))
527  END DO
528 
529  DO j=1,neta_eq
530  g_11(:,j)=g_11(:,j)*dpsidr*dpsidr
531  g_12(:,j)=g_12(:,j)*dpsidr
532  END DO
533 
534  g_13=0._r8
535  g_23=0._r8
536  g_33=1./(rr*rr)
537 
538  eq_out(1)%coord_sys%jacobian=sqrt( (g_11*g_22-g_12*g_12)*g_33 )
539 
540 !... find the quantities needed by the transport solver
541 !... fs avg is trivial for this model
542 
543  surface=tpi*tpi*r00*ra
544  area=pi*ra*ra
545 
546  CALL l3deriv(volume,psi,nr_eq,vprime,psi,nr_eq)
547  CALL l3deriv(area,psi,nr_eq,aprime,psi,nr_eq)
548 
549 !... trapped fraction for zero nu star from Wesson p 671
550 
551  ftrap=rtor/r00
552  ftrap=1._r8 - ((1._r8-ftrap)**2._r8) &
553  /( sqrt((1._r8-ftrap)**2._r8)*(1._r8+1.46_r8*sqrt(ftrap)) )
554 
555 !... set remaining 1d profiles
556 
557  eq_out(1)%profiles_1d%omega=0.
558  eq_out(1)%profiles_1d%omegaprime=0.
559  eq_out(1)%profiles_1d%mach_a=0.
560  eq_out(1)%profiles_1d%phi_flow=0.
561  eq_out(1)%profiles_1d%s_flow=0.
562  eq_out(1)%profiles_1d%h_flow=0.
563 
564 
565 !... set remaining global parameters
566 
567  eq_out(1)%global_param%volume = tpi*pi*r00*a00*a00
568  eq_out(1)%global_param%area = pi*a00*a00
569  eq_out(1)%global_param%psi_ax = psi(1)
570  eq_out(1)%global_param%psi_bound = psi(nr_eq)
571  eq_out(1)%global_param%q_95 = qq(nr_eq)
572  eq_out(1)%global_param%q_min = minval(abs(qq))*sign(1.0_r8,qq(nr_eq))
573 
574 !... global integrals Wesson defs pp 116, 120
575 !... beta normal is beta_tor B a/(I_p/1 MA)
576 
577  pvol=0._r8
578  parea=0._r8
579  barea=0._r8
580  iplasma=0._r8
581  DO i=1,nr_eq-1
582  hra=volume(i+1)-volume(i)
583  pvol=pvol+0.5_r8*hra*(pressure(i+1)+pressure(i))
584  hra=area(i+1)-area(i)
585  parea=parea+0.5_r8*hra*(pressure(i+1)+pressure(i))
586  iplasma=iplasma+0.5_r8*hra*(jtor(i+1)+jtor(i))
587  dpsi=(ra(i+1)+ra(i))/(qq(i+1)+qq(i))
588  barea=barea+hra*dpsi*dpsi
589  END DO
590  pvol=pvol/eq_out(1)%global_param%volume
591  barea=barea/eq_out(1)%global_param%area
592 
593  eq_out(1)%global_param%i_plasma = iplasma
594  eq_out(1)%global_param%beta_tor = pvol*2.0_r8*mu_0/(b00*b00)
595  eq_out(1)%global_param%beta_pol = 8.0_r8*pi*parea/(mu_0*iplasma*iplasma)
596  eq_out(1)%global_param%li = barea*qq(nr_eq)*qq(nr_eq)/(a00*a00)
597 
598  eq_out(1)%global_param%beta_normal = &
599  eq_out(1)%global_param%beta_tor*a00*abs(b00/(iplasma*1.e-6_r8))
600 
601 !... stamp time
602 
603  eq_out(1)%time=eq_in(1)%time
604 
605 !... write out output cpos
606 
607  IF (write_cpos) THEN
608 
609  call open_write_file(12, 'EqOut' )
610  call write_cpo(eq_out(1), 'EqOut' )
611  call close_write_file
612 
613  END IF
614 
615 END SUBROUTINE bdseq
616 
617 
623 SUBROUTINE l3interp2(y_out,x_in,x_out,neta)
624 
625  USE phys_constants
626 
627  IMPLICIT NONE
628 
629  INTEGER(ITM_I4) :: neta
630  REAL(R8), DIMENSION(neta), INTENT(IN) :: x_in,x_out
631  REAL(R8), DIMENSION(neta), INTENT(INOUT) :: y_out
632 
633  REAL(R8), DIMENSION(:), ALLOCATABLE :: y_in
634 
635  REAL(R8) :: x,aintm,aint0,aint1,aint2,xm,x0,x1,x2
636  INTEGER(ITM_I4) :: j,jm,j0,j1,j2
637 
638  ALLOCATE(y_in(neta))
639  y_in=y_out
640 
641  j1=1
642  DO j=1,neta
643  x=x_out(j)
644  DO WHILE (x >= x_in(j1) .AND. j1 < neta)
645  j1=j1+1
646  END DO
647  IF (j1 == neta .AND. x >= x_in(neta)) j1=j1+1
648 
649  j2=j1+1
650  j0=j1-1
651  jm=j1-2
652 
653 !... fix periodicity
654 
655  IF (jm < 1) jm=jm+neta
656  IF (j0 < 1) j0=j0+neta
657  IF (j1 > neta) j1=j1-neta
658  IF (j2 > neta) j2=j2-neta
659 
660 !... get positions
661 
662  x2=x_in(j2)
663  x1=x_in(j1)
664  x0=x_in(j0)
665  xm=x_in(jm)
666 
667 !... fix periodicity
668 
669  IF (xm < 0.0_r8) xm=xm+tpi
670  IF (x0 < 0.0_r8) x0=x0+tpi
671  IF (x1 > tpi) x1=x1-tpi
672  IF (x2 > tpi) x2=x2-tpi
673 
674 !... apply
675 
676  aintm=(x-x0)*(x-x1)*(x-x2)/((xm-x0)*(xm-x1)*(xm-x2))
677  aint0=(x-xm)*(x-x1)*(x-x2)/((x0-xm)*(x0-x1)*(x0-x2))
678  aint1=(x-xm)*(x-x0)*(x-x2)/((x1-xm)*(x1-x0)*(x1-x2))
679  aint2=(x-xm)*(x-x0)*(x-x1)/((x2-xm)*(x2-x0)*(x2-x1))
680 
681  y_out(j)=aintm*y_in(jm)+aint0*y_in(j0) &
682  +aint1*y_in(j1)+aint2*y_in(j2)
683 
684  END DO
685 
686  DEALLOCATE(y_in)
687 
688 END SUBROUTINE l3interp2
subroutine l3deriv(y_in, x_in, nr_in, dydx_out, x_out, nr_out)
Definition: l3interp.f90:59
subroutine bdseq(eq_in, eq_out, code_parameters)
Module implementing a simple equilibrium using CPOs.
Definition: bdseq.F90:6
subroutine assign_equil_parameters(code_parameters, return_status)
subroutine l3interp2(y_out, x_in, x_out, neta)
periodic interpolation on second dimension
Definition: bdseq.F90:688
subroutine l3interp(y_in, x_in, nr_in, y_out, x_out, nr_out)
Definition: l3interp.f90:1
real(r8) function pressure(flux)