17 integer,
parameter :: BUFLEN = 256
33 REAL(R8),
INTENT(IN) :: x_in(:), y_in(:), x_out(:)
34 REAL(R8) ::
interpolate(size(x_out)), y_out(size(x_out))
36 call
l3interp(y_in, x_in,
size(x_in), y_out, x_out,
size(x_out))
60 character (len=BUFLEN) :: function_string
61 real(R8),
ALLOCATABLE :: rho_1(:), rho_2(:), rho_3(:), rho_4(:), rho_5(:)
66 allocate(rho_1(0:10*nrho), rho_2(0:10*nrho), rho_3(0:10*nrho), rho_4(nrho), rho_5(nrho))
67 rho_1 = (/ (1.0_r8/(10*nrho) * (irho), irho=0,nrho*10) /)
68 rho_2 =
profile(function_string, rho_1)
71 call
cubint(10*nrho+1, rho_1, rho_2, 1, irho+1, rho_3(irho), dummy1)
73 rho_3=rho_3/rho_3(10*nrho)
74 rho_4 = (/ (1.0_r8/(nrho-1) * (irho-1), irho=1,nrho) /)
75 call
l3interp(rho_1, rho_3, 10*nrho+1, rho_5, rho_4, nrho)
77 deallocate(rho_1, rho_2, rho_3, rho_4, rho_5)
98 real(R8) :: x(:),
profile(1:size(x))
99 character (len=BUFLEN) :: function_string
101 type(equationparser
) :: function_descriptor
102 character(len=10) :: variables(1) = [
'x']
106 function_descriptor = equationparser(trim(function_string), variables)
113 profile(i) = function_descriptor%evaluate([x(i)])
120 subroutine cubint ( ntab, xtab, ftab, ia_in, ib_in, result, error )
121 USE itm_types
, only : r8
222 write ( *,
'(a)' )
' '
223 write ( *,
'(a)' )
'CUBINT - Fatal error!'
224 write ( *,
'(a,i8)' )
' NTAB must be at least 4, but input NTAB = ', ntab
229 write ( *,
'(a)' )
' '
230 write ( *,
'(a)' )
'CUBINT - Fatal error!'
231 write ( *,
'(a,i8)' )
' IA must be at least 1, but input IA = ', ia
235 if ( ntab < ia )
then
236 write ( *,
'(a)' )
' '
237 write ( *,
'(a)' )
'CUBINT - Fatal error!'
238 write ( *,
'(a,i8)' )
' IA must be <= NTAB, but input IA = ', ia
243 write ( *,
'(a)' )
' '
244 write ( *,
'(a)' )
'CUBINT - Fatal error!'
245 write ( *,
'(a,i8)' )
' IB must be at least 1, but input IB = ', ib
249 if ( ntab < ib )
then
250 write ( *,
'(a)' )
' '
251 write ( *,
'(a)' )
'CUBINT - Fatal error!'
252 write ( *,
'(a,i8)' )
' IB must be <= NTAB, but input IB = ', ib
273 if ( ia < ntab-1 .or. ntab == 4 )
then
278 if ( 2 < ib .or. ntab == 4 )
then
279 k = min( ntab, ib + 2 ) - 1
286 h2 = xtab(j-1) - xtab(j-2)
287 d3 = ( ftab(j-1) - ftab(j-2) ) / h2
288 h3 = xtab(j) - xtab(j-1)
289 d1 = ( ftab(j) - ftab(j-1) ) / h3
291 d2 = ( d1 - d3 ) / h1
292 h4 = xtab(j+1) - xtab(j)
293 r1 = ( ftab(j+1) - ftab(j) ) / h4
294 r2 = ( r1 - d1 ) / ( h4 + h3 )
299 result = h2 * ( ftab(1) + h2 * ( 0.5_r8 * d3 - h2 &
300 * ( d2 / 6.0_r8 -(h2+h3+h3)*r3/12.0_r8)))
301 s = -h2**3 * (h2*(3.0_r8*h2+5.0_r8*h4)+10.0_r8*h3*h1) / 60.0_r8
306 h4 = xtab(i+1) - xtab(i)
307 r1 = ( ftab(i+1) - ftab(i) ) / h4
309 r2 = ( r1 - d1 ) / r4
311 r3 = (
r2 - d2 ) / r4
312 r4 = ( r3 - d3 ) / ( r4 + h1 )
316 if ( ia < i .and. i <= ib )
then
318 term = h3 * ( ( ftab(i) + ftab(i-1) ) * 0.5_r8 &
319 -h3 * h3 * ( d2 +
r2 + ( h2 - h4 ) * r3 ) / 12.0_r8 )
320 result = result + term
321 c = h3**3 * ( 2.0_r8 * h3 * h3 &
322 + 5.0_r8 * ( h3 * ( h4 + h2 ) + 2.0_r8 * h2 * h4 ) ) / 120.0_r8
323 error = error + (c+s)*r4
333 error = error + r4 * s
339 if ( ntab <= ib )
then
340 term = h4 * ( ftab(ntab) - h4 * ( 0.5 * r1 &
341 + h4 * (
r2 / 6.0_r8 + ( h3 + h3 + h4 ) * r3 / 12.0_r8 )))
342 result = result + term
343 error = error - h4**3 * r4 * &
344 ( h4 * ( 3.0_r8 * h4 + 5.0_r8 * h2 ) &
345 + 10.0_r8 * h3 * ( h2 + h3 + h4 ) ) / 60.0_r8
348 if ( ntab-1 <= ib )
then
349 error = error + s * r4
379 subroutine avint ( ntab, xtab, ytab, a, b, result )
380 USE itm_types
, only : r8
487 write ( *,
'(a)' )
' '
488 write ( *,
'(a)' )
'AVINT - Fatal error!'
489 write ( *,
'(a,i8)' )
' NTAB is less than 3. NTAB = ', ntab
495 if ( xtab(i) <= xtab(i-1) )
then
496 write ( *,
'(a)' )
' '
497 write ( *,
'(a)' )
'AVINT - Fatal error!'
498 write ( *,
'(a)' )
' XTAB(I) is not greater than XTAB(I-1).'
499 write ( *,
'(a,i8)' )
' Here, I = ', i
500 write ( *,
'(a,g14.6)' )
' XTAB(I-1) = ', xtab(i-1)
501 write ( *,
'(a,g14.6)' )
' XTAB(I) = ', xtab(i)
509 if ( ntab == 2 )
then
510 slope = ( ytab(2) - ytab(1) ) / ( xtab(2) - xtab(1) )
511 fa = ytab(1) + slope * ( a - xtab(1) )
512 fb = ytab(2) + slope * ( b - xtab(2) )
513 result = 0.5_r8 * ( fa + fb ) * ( b - a )
517 if ( xtab(ntab-2) < a .or. b < xtab(3) )
then
518 write ( *,
'(a)' )
' '
519 write ( *,
'(a)' )
'AVINT - Fatal error!'
520 write ( *,
'(a)' )
' There were less than 3 function values'
521 write ( *,
'(a)' )
' between the limits of integration.'
528 if ( a <= xtab(i) )
then
542 if ( xtab(i) <= b )
then
552 if ( inrt - inlft < 2 )
then
553 write ( *,
'(a)' )
' '
554 write ( *,
'(a)' )
'AVINT - Fatal error!'
555 write ( *,
'(a)' )
' There were less than 3 function values'
556 write ( *,
'(a)' )
' between the limits of integration.'
560 if ( inlft == 1 )
then
566 if ( inrt == ntab )
then
588 term1 = ( ytab(i-1) ) / ( x12 * x13 )
589 term2 = - ( ytab(i) ) / ( x12 * x23 )
590 term3 = ( ytab(i+1) ) / ( x13 * x23 )
592 ba = term1 + term2 + term3
593 bb = - ( x2 + x3 ) * term1 - ( x1 + x3 ) * term2 - ( x1 + x2 ) * term3
594 bc = x2 * x3 * term1 + x1 * x3 * term2 + x1 * x2 * term3
596 if ( i == istart )
then
601 ca = 0.5_r8 * ( ba + ca )
602 cb = 0.5_r8 * ( bb + cb )
603 cc = 0.5_r8 * ( bc + cc )
610 total = total + ca * ( syu3 - syl3 ) / 3.0_r8 &
611 + cb * ( syu2 - syl2 ) / 2.0_r8 &
627 result = total + ca * ( syu3 - syl3 ) / 3.0_r8 &
628 + cb * ( syu2 - syl2 ) / 2.0_r8 &
640 SUBROUTINE l3interp(y_in,x_in,nr_in,y_out,x_out,nr_out)
646 INTEGER(ITM_I4) :: nr_in,nr_out
647 REAL(R8),
DIMENSION(nr_in),
INTENT(IN) :: y_in,x_in
648 REAL(R8),
DIMENSION(nr_out),
INTENT(IN) :: x_out
649 REAL(R8),
DIMENSION(nr_out),
INTENT(OUT) :: y_out
651 REAL(R8) :: x,aintm,aint0,aint1,aint2,xm,x0,x1,x2
652 INTEGER(ITM_I4) :: j,jm,j0,j1,j2
653 INTEGER :: jstart,jfirst,jlast,jstep
655 IF (x_in(nr_in) > x_in(1))
THEN
668 DO j=jfirst,jlast,jstep
670 DO WHILE (x >= x_in(j1) .AND. j1 < nr_in-1 .AND. j1 > 2)
685 aintm=(x-x0)*(x-x1)*(x-x2)/((xm-x0)*(xm-x1)*(xm-x2))
686 aint0=(x-xm)*(x-x1)*(x-x2)/((x0-xm)*(x0-x1)*(x0-x2))
687 aint1=(x-xm)*(x-x0)*(x-x2)/((x1-xm)*(x1-x0)*(x1-x2))
688 aint2=(x-xm)*(x-x0)*(x-x1)/((x2-xm)*(x2-x0)*(x2-x1))
690 y_out(j)=aintm*y_in(jm)+aint0*y_in(j0) &
691 +aint1*y_in(j1)+aint2*y_in(j2)
704 SUBROUTINE l3deriv(y_in,x_in,nr_in,dydx_out,x_out,nr_out)
710 INTEGER(ITM_I4) :: nr_in,nr_out
711 REAL(R8),
DIMENSION(nr_in),
INTENT(IN) :: y_in,x_in
712 REAL(R8),
DIMENSION(nr_out),
INTENT(IN) :: x_out
713 REAL(R8),
DIMENSION(nr_out),
INTENT(OUT) :: dydx_out
715 REAL(R8) :: x,aintm,aint0,aint1,aint2,xm,x0,x1,x2
716 INTEGER(ITM_I4) :: j,jm,j0,j1,j2
717 INTEGER(ITM_I4) :: jstart,jfirst,jlast,jstep
719 IF (x_in(nr_in) > x_in(1))
THEN
732 DO j=jfirst,jlast,jstep
734 DO WHILE (x >= x_in(j1) .AND. j1 < nr_in-1 .AND. j1 > 2)
749 aintm=((x-x1)*(x-x2)+(x-x0)*(x-x2)+(x-x0)*(x-x1)) &
750 /((xm-x0)*(xm-x1)*(xm-x2))
751 aint0=((x-x1)*(x-x2)+(x-xm)*(x-x2)+(x-xm)*(x-x1)) &
752 /((x0-xm)*(x0-x1)*(x0-x2))
753 aint1=((x-x0)*(x-x2)+(x-xm)*(x-x2)+(x-xm)*(x-x0)) &
754 /((x1-xm)*(x1-x0)*(x1-x2))
755 aint2=((x-x0)*(x-x1)+(x-xm)*(x-x1)+(x-xm)*(x-x0)) &
756 /((x2-xm)*(x2-x0)*(x2-x1))
758 dydx_out(j)=aintm*y_in(jm)+aint0*y_in(j0) &
759 +aint1*y_in(j1)+aint2*y_in(j2)
778 INTEGER(ITM_I4) :: nx
779 REAL(R8) :: dxp,dxm,dx0
780 REAL(R8),
DIMENSION(nx),
INTENT(IN) :: x,y
781 REAL(R8),
DIMENSION(nx),
INTENT(OUT) :: dydx
783 INTEGER(ITM_I4) :: i,ip,im
791 dydx(i)=(dxm*dxm*(y(ip)-y(i))+dxp*dxp*(y(i)-y(im)))/(dxm*dxp*dx0)
793 dydx(1)=2.*dydx(2) - dydx(3)
794 dydx(nx)=2.*dydx(nx-1) - dydx(nx-2)
subroutine l3deriv(y_in, x_in, nr_in, dydx_out, x_out, nr_out)
subroutine avint(ntab, xtab, ytab, a, b, result)
subroutine l3interp(y_in, x_in, nr_in, y_out, x_out, nr_out)
subroutine lderiv(y, x, dydx, nx)
real(r8) function, dimension(1:size(x)) profile(function_string, x)
real(r8) function r2(a, x, xr, xs, yr, ys, psi, psir, F_dia)
subroutine cubint(ntab, xtab, ftab, ia_in, ib_in, result, error)