33 INTEGER,
INTENT (INOUT) :: ifail
42 REAL (R8) :: rho(
solver%nrho)
48 REAL (R8) :: dy(
solver%nrho)
50 REAL (R8) :: yy(
solver%nrho)
55 REAL (R8) :: g(
solver%nrho), h
58 REAL (R8) :: v(2), u(2), w(2)
76 equation_loop1:
DO idim = 1, ndim
77 IF (
solver%EQ_FLAG(idim).EQ.0) goto 20
86 rho_loop1:
DO irho=1,nrho
87 rho(irho) =
solver%RHO(irho)
89 y(irho) =
solver%Y(idim,irho)
90 dy(irho) =
solver%DY(idim,irho)
91 ym(irho) =
solver%YM(idim,irho)
93 a(irho) =
solver%A(idim,irho)
94 b(irho) =
solver%B(idim,irho)
95 c(irho) =
solver%C(idim,irho)
96 d(irho) =
solver%D(idim,irho)
97 e(irho) =
solver%E(idim,irho)
98 f(irho) =
solver%F(idim,irho)
99 g(irho) =
solver%G(idim,irho)
121 CALL
fem_pde_solver(a,b,c,d,dd,e,de,f,g,h, &
122 ym,yy,rho,nrho,u, v, w)
127 y = y*(1.e0_r8-amix) + yy*amix
136 END DO equation_loop1
151 SUBROUTINE fem_pde_solver (A,B,C,D,DD,E,DE,F,G,dt_in,&
160 INTEGER,
INTENT(in) :: n
162 REAL (R8),
INTENT(in) :: x(n), dt_in
163 REAL (R8),
INTENT(in) :: a(n),b(n),c(n),d(n),e(n),f(n)
164 REAL (R8),
INTENT(in) :: g(n),dd(n),de(n),ym(n)
166 REAL (R8),
INTENT(in) :: u(2), v(2), w(2)
168 REAL (R8),
INTENT(inOUT) :: yy(n)
172 REAL (R8),
DIMENSION(:,:),
ALLOCATABLE :: mat,det,kof,det1,det2,det3
174 REAL (R8),
DIMENSION(:,:),
ALLOCATABLE :: rhs,rhs_dirichle,&
178 INTEGER,
DIMENSION(:),
ALLOCATABLE :: pivot, pivot_dirichle
182 REAL (R8) :: ksi(4), weight(4)
183 REAL (R8) :: n1(4), n2(4)
184 REAL (R8) :: nn1(2,2), nn2(2,2), nn3(2,2), nn4(2,2)
185 REAL (R8) :: dnn1(2,2), dnn2(2,2), dnn3(2,2), dnn4(2,2)
186 REAL (R8) :: dndn(2,2)
189 INTEGER :: k, i,j, i1, i2
193 REAL (R8) :: a_in(4), b_in(4), c_in(4), d_in(4)
194 REAL (R8) :: e_in(4), f_in(4), g_in(4)
195 REAL (R8) :: de_in(4), dd_in(4)
196 REAL (R8) :: af(4), bf(4), cf(4), df(4)
199 REAL (R8) :: matlok(2,2), koflok(1,2)
200 REAL (R8) :: det1lok(2,2),det2lok(2,2), det3lok(2,2)
203 REAL (R8) :: pom1(1,2), pom2(2,1)
204 REAL (R8) :: tmp1(4,2), tmp22(4), tmp2(1,4)
217 ALLOCATE(rhs_dirichle(1,n-1))
218 ALLOCATE(lhs_dirichle(n-1,n-1))
220 ALLOCATE(pivot_dirichle(n-1))
234 rhs_dirichle(1,:)=0.0e0_r8
235 lhs_dirichle(:,:)=0.0e0_r8
238 ksi = (/-0.86113631e0_r8,-0.33998104e0_r8,&
239 0.33998104e0_r8,0.86113631e0_r8/)
240 weight = (/ 0.34785485e0_r8,0.65214515e0_r8,&
241 0.65214515e0_r8,0.34785485e0_r8/)
251 nn1 = matmul(pom2,pom1)
257 nn2 = matmul(pom2,pom1)
263 nn3 = matmul(pom2,pom1)
269 nn4 = matmul(pom2,pom1)
271 dndn = reshape((/1, -1, -1, 1/), shape(dndn))
275 solveeqloop:
DO k =1, n-1
285 dnn1 = matmul(pom2,pom1)
289 dnn2 = matmul(pom2,pom1)
293 dnn3 = matmul(pom2,pom1)
297 dnn4 = matmul(pom2,pom1)
300 a_in = a(k) * n1 + a(k+1) *n2
301 b_in = b(k) * n1 + b(k+1) *n2
302 c_in = c(k) * n1 + c(k+1) *n2
303 d_in = d(k) * n1 + d(k+1) *n2
304 e_in = e(k) * n1 + e(k+1) *n2
305 f_in = f(k) * n1 + f(k+1) *n2
306 g_in = g(k) * n1 + g(k+1) *n2
307 de_in = de(k) * n1 + de(k+1) *n2
308 dd_in = dd(k) * n1 + dd(k+1) *n2
312 (( c_in(1)*a_in(1) + c_in(1)*g_in(1)*dt_in + de_in(1)*dt_in )*nn1*weight(1) +&
313 ( c_in(2)*a_in(2) + c_in(2)*g_in(2)*dt_in + de_in(2)*dt_in )*nn2*weight(2) +&
314 ( c_in(3)*a_in(3) + c_in(3)*g_in(3)*dt_in + de_in(3)*dt_in )*nn3*weight(3) +&
315 ( c_in(4)*a_in(4) + c_in(4)*g_in(4)*dt_in + de_in(4)*dt_in )*nn4*weight(4) )
317 det1lok = (delx/2) * (dt_in*e_in(1)*dnn1*weight(1) + dt_in*e_in(2)*dnn2*weight(2) +&
318 dt_in*e_in(3)*dnn3*weight(3) + dt_in*e_in(4)*dnn4*weight(4))
321 det2lok = 1/(2*delx) *(dt_in*d_in(1)*weight(1) + dt_in*d_in(2)*weight(2) +&
322 dt_in*d_in(3)*weight(3) + dt_in*d_in(4)*weight(4)) * dndn
324 det3lok = (delx/2) * (c_in(1)*b_in(1)*nn1*weight(1) + c_in(2)*b_in(2)*nn2*weight(2) +&
325 c_in(3)*b_in(3)*nn3*weight(3) + c_in(4)*b_in(4)*nn4*weight(4))
329 tmp1 = reshape((/n1,n2/),shape(tmp1))
330 tmp22 = (c_in*f_in)*weight*dt_in
331 tmp2 = reshape((/tmp22/),shape(tmp2))
332 koflok = matmul(tmp2,tmp1)
333 koflok = (delx/2)*koflok
338 mat(i1:i2,i1:i2)= mat(i1:i2,i1:i2)+matlok
339 det1(i1:i2,i1:i2)=det1(i1:i2,i1:i2)+det1lok
340 det2(i1:i2,i1:i2)=det2(i1:i2,i1:i2)+det2lok
341 det3(i1:i2,i1:i2)=det3(i1:i2,i1:i2)+det3lok
342 kof(:,i1:i2)=kof(:,i1:i2)+koflok
347 lhs = mat + det1 + det2
350 rhs = reshape( (/ym/), shape(rhs))
351 rhs = matmul(rhs,det3) + kof
360 rhs(1,n)=rhs(1,n)+w(2)/v(2)*d(n)*dt_in
361 lhs(n,n) = lhs(n,n) + u(2)/v(2)*d(n)*dt_in
364 CALL dgesv(n, 1, lhs, n, pivot, rhs, n, ok)
368 ELSEIF (v(2).EQ.0)
THEN
376 lhs_dirichle(i,j) = lhs(i,j)
383 rhs_dirichle(1,i) = rhs(1,i) - w(2)/u(2) * lhs(n,i)
386 lhs_dirichle = transpose(lhs_dirichle)
388 call dgesv(n-1, 1, lhs_dirichle, n-1, pivot_dirichle, rhs_dirichle, n-1, ok)
390 rhs(1,:n-1) = rhs_dirichle(1,:)
401 IF(
ALLOCATED(pivot))
DEALLOCATE(pivot)
402 IF(
ALLOCATED(pivot_dirichle))
DEALLOCATE(pivot_dirichle)
404 IF(
ALLOCATED(mat))
DEALLOCATE(mat)
405 IF(
ALLOCATED(det))
DEALLOCATE(det)
406 IF(
ALLOCATED(kof))
DEALLOCATE(kof)
409 IF(
ALLOCATED(det1))
DEALLOCATE(det1)
410 IF(
ALLOCATED(det2))
DEALLOCATE(det2)
411 IF(
ALLOCATED(det3))
DEALLOCATE(det3)
414 IF(
ALLOCATED(rhs))
DEALLOCATE(rhs)
415 IF(
ALLOCATED(lhs))
DEALLOCATE(lhs)
418 IF(
ALLOCATED(rhs_dirichle))
DEALLOCATE(rhs_dirichle)
419 IF(
ALLOCATED(lhs_dirichle))
DEALLOCATE(lhs_dirichle)
439 INTEGER,
INTENT(in) :: n
440 REAL (r8),
INTENT(in) :: x1(n), f(n)
441 REAL (r8),
INTENT (out) :: fc(n)
443 fc(1)= (-1.0)*(-1.0/2.0)*((f(1)-f(2))/(x1(1)-x1(2)))&
444 &+(-2.0)*(-1.0) *((f(1)-f(3))/(x1(1)-x1(3)))&
445 &+(-3.0)*(1.0/2.0) *((f(1)-f(4))/(x1(1)-x1(4)))
447 fc(2)= (-1.0)*(-1.0/2.0)*((f(2)-f(3))/(x1(2)-x1(3)))&
448 &+(-2.0)*(-1.0) *((f(2)-f(4))/(x1(2)-x1(4)))&
449 &+(-3.0)*(1.0/2.0) *((f(2)-f(5))/(x1(2)-x1(5)))
451 fc(3)= ((1.0/4.0)*((f(4)-f(2))/(x1(4)-x1(2)))*(2.0*1.0)) &
452 &+((1.0/8.0)*((f(5)-f(1))/(x1(5)-x1(1)))*(2.0*2.0))
454 fc(4:n-1-2)= ((5.0/32.0)*((f(5:n-1-1)-f(3:n-1-3))/(x1(5:n-1-1)-x1(3:n-1-3)))*2.0*1.0)&
455 &+(1.0/8.00)*((f(6:n-1) -f(2:n-1-4))/(x1(6:n-1) -x1(2:n-1-4)))*2.0*2.0&
456 &+(1.0/32.0)*((f(7:n-1+1)-f(1:n-1-5))/(x1(7:n-1+1)-x1(1:n-1-5)))*2.0*3.0
458 fc(n-1-1)= (((1.0/4.0)*((f(n-1+1-1)-f(n-1+1-2))/(x1(n-1+1-1)-x1(n-1+1-2)))*(2*1))&
459 &+((1.0/8.0)*((f(n-1+1) -f(n-1+1-4))/(x1(n-1+1) -x1(n-1+1-4)))*(2*2)))
461 fc(n-1)= (-1.0)*(-1.0/2.0)*((f(n-1+1-1)-f(n-1+1-2))/(x1(n-1+1-1)-x1(n-1+1-2)))&
462 &+(-2.0)*(-1.0) *((f(n-1+1-1)-f(n-1+1-3))/(x1(n-1+1-1)-x1(n-1+1-3)))&
463 &+(-3.0)*(1.0/2.0) *((f(n-1+1-1)-f(n-1+1-4))/(x1(n-1+1-1)-x1(n-1+1-4)))
465 fc(n-1+1)= (-1.0)*(-1.0/2.0)*((f(n-1+1)-f(n-1+1-1))/(x1(n-1+1)-x1(n-1+1-1)))&
466 &+(-2.0)*(-1.0) *((f(n-1+1)-f(n-1+1-2))/(x1(n-1+1)-x1(n-1+1-2)))&
467 &+(-3.0)*(1.0/2.0) *((f(n-1+1)-f(n-1+1-3))/(x1(n-1+1)-x1(n-1+1-3)))
subroutine solutionfem(SOLVER, ifail)
This subroutine is prepared to solve single transport equation in standardised form adopted by the ET...
subroutine fem_pde_solver(A, B, C, D, DD, E, DE, F, G, dt_in, YM, YY, X, N, U, V, W)
subroutine deriv_holob(N, X1, F, FC)
These subroutines calculate derivative, DY of function Y respect to argument X.