1 subroutine psiloop(rlop,zlop,psilop,nlop)
4 dimension rlop(*),zlop(*),psilop(*)
13 subroutine b_prob(rprob,zprob,hrprob,hzprob,nprob,bprob)
16 dimension rprob(*),zprob(*),hrprob(*),hzprob(*),bprob(*)
18 call
bprob_e(rprob,zprob,hrprob,hzprob,nprob,bprob)
19 call
bprob_p(rprob,zprob,hrprob,hzprob,nprob,bprob)
25 subroutine bprob_p(rprob,zprob,hrprob,hzprob,nprob,bprob)
33 include
'compol_add.inc'
35 dimension rprob(*),zprob(*),hrprob(*),hzprob(*),bprob(*)
36 dimension rsh(nshp),zsh(nshp),ush(nshp)
50 if(iprprob(ik).eq.1)
then
53 write(*,*)
'probe',ik,
'is out of box'
54 write(*,*)
'program is terminated'
63 dist=sqrt( (r0-r(is,js))**2 + (z0-z(is,js))**2 )
64 if(dist .lt. dismin)
then
73 if(ick.eq.nr) ick=nr-1
78 ush(nsh)=psii(ick,jck)
83 if(ii.ne.0 .or. jj.ne.0)
then
92 call
deriv5(rsh,zsh,ush,nsh,5,dp)
94 dudr=dp(1)+dp(3)*(r0-rsh(1))+dp(4)*(z0-zsh(1))
95 dudz=dp(2)+dp(5)*(z0-zsh(1))+dp(4)*(r0-rsh(1))
99 bpla=br*hrprob(ik)+bz*hzprob(ik)
100 bprob(ik)=bprob(ik)+bpla
105 write(*,*)
'bprob_p:prob is in the box',ic,nr
106 write(*,*)
'program is terminated'
107 write(*,*)
'you need to consult program provider'
118 dudr = dudr-adginr(ik_out,j)*(dgdn(j)+dgdn(j+1))*0.5d0
119 dudz = dudz-adginz(ik_out,j)*(dgdn(j)+dgdn(j+1))*0.5d0
125 bpla=br*hrprob(ik)+bz*hzprob(ik)
126 bprob(ik)=bprob(ik)+bpla
132 if(ik_out.ne.nprob_out)
then
133 write(*,*) .ne.
'bprob_p:ik_outnprob_out',ik_out,nprob_out
134 write(*,*)
'program is terminated'
135 write(*,*)
'you need to consult program provider'
144 subroutine blic_d(r0,z0, r1,r2,r3,r4, z1,z2,z3,z4,
145 * u1,u2,u3,u4, u0, dudr,dudz)
188 cx = dr-r0-cr/(-az*cr+ar*cz)*az*r0+cr/(-az*cr+ar*cz)*az*dr+cr/(-az
189 #*cr+ar*cz)*ar*z0-cr/(-az*cr+ar*cz)*ar*dz
191 bx = -ar/(-az*cr+ar*cz)*az*r0+ar/(-az*cr+ar*cz)*az*dr+ar**2/(-az*c
192 #r+ar*cz)*z0-ar**2/(-az*cr+ar*cz)*dz+cr/(-az*cr+ar*cz)*az*br-cr/(-a
193 #z*cr+ar*cz)*ar*bz+br
195 ax = ar/(-az*cr+ar*cz)*az*br-ar**2/(-az*cr+ar*cz)*bz
197 if(abs(ax/bx).lt.1.d-8)
then
202 det_=bx**2-4.d0*ax*cx
203 if(det_.lt.0.d0)
then
204 write(*,*)
'blic_d: det<0'
207 x1 = 0.5d0*(-bx + sqrt(det_))/ax
208 x2 = 0.5d0*(-bx - sqrt(det_))/ax
209 if(x1.ge.0.d0 .And. x1.le.1.d0)
then
211 elseif(x2.ge.0.d0 .And. x2.le.1.d0)
then
214 write(*,*)
'blic_d: x<0 or x>1'
220 y = -(az*r0-az*br*x-az*dr-ar*z0+ar*bz*x+ar*dz)/(-az*cr+ar*cz)
222 u0=au*x*y + bu*x + cu*y + du
233 det = drdx*dzdy - drdy*dzdx
234 det_r = dudx*dzdy - dudy*dzdx
235 det_z = drdx*dudy - drdy*dudx
246 subroutine blic_d_(r0,z0, r1,r2,r3,r4, z1,z2,z3,z4,
247 * u1,u2,u3,u4, u0, dudr,dudz)
250 dimension a(4,4),f(4),x(4),iwrk(4)
305 call
ge(4,4,a,f,x,iwrk)
307 u0=x(1)*r0+x(2)*z0+x(3)*r0*z0+x(4)
322 dimension rlop(*),zlop(*),psilop(*)
346 psilop(i)=
blin_(r0,z0,r1,
r2,z1,z2,u1,u2,u3,u4 )
362 include
'compol_add.inc'
364 real*8 psilop(*),rlop(*),zlop(*)
377 if(iprlop(ik).eq.1)
then
380 write(*,*)
'psiloop_p: bug'
381 write(*,*)
'loop',ik,
'is out of box'
382 write(*,*)
'iprlop(ik)=',iprlop(ik)
383 write(*,*)
'program is terminated'
402 call
blic_d(r0,z0,r1,
r2,r3,r4,z1,z2,z3,z4,
403 * u1,u2,u3,u4,u0,dudr,dudz)
405 psilop(ik)=psilop(ik)+u0
410 write(*,*)
'psiloop_p:loop',ik,
'is into the box',ic,nr
411 write(*,*)
'program is terminated'
412 write(*,*)
'you need to consult program provider'
420 psilop(ik)=psilop(ik)
421 * -adginl(ik_out,j)*(dgdn(j)+dgdn(j+1))*0.5d0
429 if(ik_out.ne.nlop_out)
then
430 write(*,*) .ne.
'psiloop_p:ik_outnlop_out',ik_out,nlop_out
431 write(*,*)
'program is terminated'
432 write(*,*)
'you need to consult program provider'
441 subroutine bprob_e(rprob,zprob,hrprob,hzprob,nprob,bprob)
446 dimension rprob(*),zprob(*),hrprob(*),hzprob(*),bprob(*)
470 call
blin_d(r0,z0,r1,
r2,z1,z2,u1,u2,u3,u4,dudr,dudz)
474 bprob(i)=br*hrprob(i)+bz*hzprob(i)
488 include
'compol_add.inc'
515 psie(i,j)=
blin_(r0,z0,r1,
r2,z1,z2,u1,u2,u3,u4 )
532 include
'compol_add.inc'
535 dimension psi_sur(ntp)
561 psi_sur(j)=
blin_(r0,z0,r1,
r2,z1,z2,u1,u2,u3,u4 )
579 include
'compol_add.inc'
585 psi(i,j)=psii(i,j)+psie(i,j)
604 subroutine blin_d(r0,z0,r1,r2,z1,z2,u1,u2,u3,u4,dudr,dudz)
609 dudr=( (u2-u1)*(z2-z0)+(u3-u4)*(z0-z1) )/s
610 dudz=( (u4-u1)*(
r2-r0)+(u3-u2)*(r0-r1) )/s
623 parameter(nshp=ntp+1)
625 include
'compol_add.inc'
627 dimension xs(nshp),ys(nshp),
fun(nshp),dpm(5)
639 write(*,*)
'artfil:psi(1,1)',
fun(nsh)
653 clrn= -dpm(1)*0.5d0/rm
658 clr=sigma*clrn+(1.d0-sigma)*clr
659 clz=sigma*clzn+(1.d0-sigma)*clz
664 psi(i,j)=psi(i,j)+clz*z(i,j)+clr*r(i,j)*r(i,j)
680 include
'compol_add.inc'
682 dimension dp(10),xs(nshp),ys(nshp),
fun(nshp)
700 ro0=sqrt(dr0**2+dz0**2)
709 if(tet0.lt.teta(1)) tet0=tet0+2.d0*pi
710 if(tet0.gt.teta(nt)) tet0=tet0-2.d0*pi
714 if(tet0.ge.teta(j) .AND. tet0.lt.teta(j+1)) jc=j
723 dromn=sqrt((r(i+1,jc)-rx)**2+(z(i+1,jc)-zx)**2)
724 dropl=sqrt((r(i+1,jc+1)-rx)**2+(z(i+1,jc+1)-zx)**2)
726 if(dropl.le.dro .AND. dropl.le.dromn)
then
732 elseif(dromn.le.dro .AND. dromn.le.dropl)
then
765 if(k.eq.0 .AND. l.eq.0 ) go to 410
766 if(i.gt.nr ) go to 410
787 if(i.gt.nr ) go to 500
798 det = dp(3)*dp(5) - dp(4)**2
800 rx = xs(1) + ( dp(2)*dp(4) - dp(1)*dp(5) )/det
801 zx = ys(1) + ( dp(1)*dp(4) - dp(2)*dp(3) )/det
806 psx=
fun(1)+ dp(1)*(rx-rrx) + dp(2)*(zx-zzx)
807 + + 0.5d0*dp(3)*(rx-rrx)*(rx-rrx)
808 + + dp(4)*(rx-rrx)*(zx-zzx)
809 + + 0.5d0*dp(5)*(zx-zzx)*(zx-zzx)
816 if( (ix.ne.ixn .OR. jx.ne.jxn).AND.(numbit.lt.10) )
then
841 include
'compol_add.inc'
843 dimension dp(10),xs(nshp),ys(nshp),
fun(nshp)
865 ro0=sqrt(dr0**2+dz0**2)
874 if(tet0.lt.teta(1)) tet0=tet0+2.d0*pi
875 if(tet0.gt.teta(nt)) tet0=tet0-2.d0*pi
879 if(tet0.ge.teta(j) .AND. tet0.lt.teta(j+1)) jc=j
887 dromn=sqrt((r(i+1,jc)-rx)**2+(z(i+1,jc)-zx)**2)
888 dropl=sqrt((r(i+1,jc+1)-rx)**2+(z(i+1,jc+1)-zx)**2)
890 if(dropl.le.dro .AND. dropl.le.dromn)
then
896 elseif(dromn.le.dro .AND. dromn.le.dropl)
then
932 if(k.eq.0 .AND. l.eq.0 ) go to 410
933 if(i.gt.nr ) go to 410
954 if(i.gt.nr ) go to 500
968 call
xpoint_e(psie_x,rx,zx,r_ix,z_jx,dp_e,kodex_e)
984 det = dp(3)*dp(5) - dp(4)**2
986 rx = xs(1) + ( dp(2)*dp(4) - dp(1)*dp(5) )/det
987 zx = ys(1) + ( dp(1)*dp(4) - dp(2)*dp(3) )/det
992 psx=
fun(1)+ dp(1)*(rx-rrx) + dp(2)*(zx-zzx)
993 + + 0.5d0*dp(3)*(rx-rrx)*(rx-rrx)
994 + + dp(4)*(rx-rrx)*(zx-zzx)
995 + + 0.5d0*dp(5)*(zx-zzx)*(zx-zzx)
1002 if( (ix.ne.ixn .OR. jx.ne.jxn).AND.(numbit.lt.10) )
then
1021 include
'double.inc'
1024 include
'comblc.inc'
1026 real*8 xs(nshp),ys(nshp),
fun(nshp),dp(5)
1033 if(rx.ge.rmax .OR. rx.le.rmin .OR.
1034 * zx.ge.zmax .OR. zx.le.zmin)
then
1035 ccc
write(6,*)
' xpoint',numxp,
'out of box'
1036 ccc
write(6,*)
' rx,zx ',rx,zx
1043 c---definition of cell, containig x-point
1047 if( (rx.lt.r(i+1)) .AND. (rx.ge.r(i)) ) go to 301
1053 if( (zx.lt.z(j+1)) .AND. (zx.ge.z(j)) ) go to 311
1057 if(icx.eq.1 .OR. icx.eq.ni1 .OR.
1058 * jcx.eq.1 .OR. jcx.eq.nj1)
then
1059 ccc
write(6,*)
' xpoint',numxp,
'in bound cell'
1060 ccc
write(6,*)
' icell,jcell ',icx,jcx
1068 ccc
write(6,*)
'icelx,jcelx',icx,jcx,rx,zx
1070 c---define nearest knote
1078 dlx=dsqrt( (rr-rx)**2+(zz-zx)**2 )
1079 if(dlx.lt.sdmin)
then
1089 ccc
write(6,*)
'ix,jx',ix,jx
1107 if(k.eq.0 .AND. l.eq.0 ) go to 410
1121 ue_x=
fun(1)+ dp(1)*(rx-rrx) + dp(2)*(zx-zzx)
1122 + + 0.5d0*dp(3)*(rx-rrx)*(rx-rrx)
1123 + + dp(4)*(rx-rrx)*(zx-zzx)
1124 + + 0.5d0*dp(5)*(zx-zzx)*(zx-zzx)
1134 subroutine axpnt_e(ue_ax,r_ax,z_ax,i_ax,j_ax,dp,kodax)
1136 include
'double.inc'
1139 include
'comblc.inc'
1141 real*8 xs(nshp),ys(nshp),
fun(nshp),dp(5)
1148 if(r_ax.ge.rmax .OR. r_ax.le.rmin .OR.
1149 * z_ax.ge.zmax .OR. z_ax.le.zmin)
then
1150 write(*,*)
'subroutine axpnt_e:'
1151 write(*,*)
' axis is out of box'
1152 write(*,*)
' r_ax,z_ax ',r_ax,z_ax
1158 c---definition of cell, containig x-point
1162 if( (r_ax.lt.r(i+1)) .AND. (r_ax.ge.r(i)) ) go to 301
1168 if( (z_ax.lt.z(j+1)) .AND. (z_ax.ge.z(j)) ) go to 311
1172 if(ic_ax.eq.1 .OR. ic_ax.eq.ni1 .OR.
1173 * jc_ax.eq.1 .OR. jc_ax.eq.nj1)
then
1174 write(*,*)
' ax_point in bound cell'
1175 write(*,*)
' icell,jcell ',ic_ax,jc_ax
1183 c---define nearest knote
1191 dl_ax=dsqrt( (rr-r_ax)**2+(zz-z_ax)**2 )
1192 if(dl_ax.lt.sdmin)
then
1202 ccc
write(6,*)
'ix,jx',ix,jx
1210 fun(nsh)=ue(i_ax,j_ax)
1220 if(k.eq.0 .AND. l.eq.0 ) go to 410
1234 ue_ax=
fun(1)+ dp(1)*(r_ax-rrax) + dp(2)*(z_ax-zzax)
1235 + + 0.5d0*dp(3)*(r_ax-rrax)*(r_ax-rrax)
1236 + + dp(4)*(r_ax-rrax)*(z_ax-zzax)
1237 + + 0.5d0*dp(5)*(z_ax-zzax)*(z_ax-zzax)
subroutine bprob_e(rprob, zprob, hrprob, hzprob, nprob, bprob)
subroutine bprob_p(rprob, zprob, hrprob, hzprob, nprob, bprob)
subroutine axpnt_e(ue_ax, r_ax, z_ax, i_ax, j_ax, dp, kodax)
subroutine numcel(rrk, zzk, icell, jcell)
subroutine blic_d(r0, z0, r1, r2, r3, r4, z1, z2, z3, z4,
subroutine f_xpoint2(rx, zx, ix, jx, psx, tet0, kodex)
subroutine deriv5(X, Y, F, M, N, U)
subroutine b_prob(rprob, zprob, hrprob, hzprob, nprob, bprob)
subroutine f_psloop_e(rlop, zlop, psilop, nlop)
subroutine blin_d(r0, z0, r1, r2, z1, z2, u1, u2, u3, u4, dudr, dudz)
real *8 function blin_(r0, z0, r1, r2, z1, z2, u1, u2, u3, u4)
real(r8) function r2(a, x, xr, xs, yr, ys, psi, psir, F_dia)
subroutine psiloop(rlop, zlop, psilop, nlop)
subroutine ge(N, NZ, A, X, Y, IP)
subroutine xpoint_e(ue_x, rx, zx, r_ix, z_jx, dp, kodex)
subroutine psloop_p(rlop, zlop, psilop, nlop)
subroutine blic_d_(r0, z0, r1, r2, r3, r4, z1, z2, z3, z4,
subroutine f_xpoint(rx, zx, ix, jx, psx, tet0, kodex)