FE-Project
Loading...
Searching...
No Matches
scale_mesh_cubedom3d.F90
Go to the documentation of this file.
1!-------------------------------------------------------------------------------
9#include "scaleFElib.h"
11 !-----------------------------------------------------------------------------
12 !
13 !++ used modules
14 !
15 use scale_io
16 use scale_precision
17 use scale_prc
18
19 use scale_mesh_base3d, only: &
22
23 use scale_mesh_base2d, only: &
26
27 use scale_localmesh_3d, only: &
31
32 use scale_mesh_rectdom2d, only: &
34
36
37 !-----------------------------------------------------------------------------
38 implicit none
39 private
40
41 !-----------------------------------------------------------------------------
42 !
43 !++ Public type & procedure
44 !
45 type, extends(meshbase3d), public :: meshcubedom3d
46 integer :: negx
47 integer :: negy
48 integer :: negz
49
50 integer :: nprcx
51 integer :: nprcy
52 integer :: nprcz
53
54 real(rp), public :: xmin_gl, xmax_gl
55 real(rp), public :: ymin_gl, ymax_gl
56 real(rp), public :: zmin_gl, zmax_gl
57
58 real(rp), allocatable :: fz(:)
59
60 integer, allocatable :: rcdomijk2lcmeshid(:,:,:)
61
62 logical :: isperiodicx
63 logical :: isperiodicy
64 logical :: isperiodicz
65
66 type(meshrectdom2d) :: mesh2d
67 type(quadrilateralelement) :: refelem2d
68 contains
69 procedure :: init => meshcubedom3d_init
70 procedure :: final => meshcubedom3d_final
71 procedure :: generate => meshcubedom3d_generate
72 procedure :: getmesh2d => meshcubedom3d_getmesh2d
73 procedure :: set_geometric_with_vcoord => meshcubedom3d_set_geometric_with_vcoord
74 end type meshcubedom3d
75
77
78 !-----------------------------------------------------------------------------
79 !
80 !++ Public parameters & variables
81 !
82
83 !-----------------------------------------------------------------------------
84 !
85 !++ Private procedure
86 !
87
88 !-----------------------------------------------------------------------------
89 !
90 !++ Private parameters & variables
91 !
92
93contains
94!OCL SERIAL
95 subroutine meshcubedom3d_init( this, &
96 NeGX, NeGY, NeGZ, &
97 dom_xmin, dom_xmax, dom_ymin, dom_ymax, dom_zmin, dom_zmax, &
98 isPeriodicX, isPeriodicY, isPeriodicZ, &
99 refElem, NLocalMeshPerPrc, NprcX, NprcY, &
100 nproc, myrank, &
101 FZ )
102
103 implicit none
104
105 class(meshcubedom3d), intent(inout) :: this
106 integer, intent(in) :: NeGX
107 integer, intent(in) :: NeGY
108 integer, intent(in) :: NeGZ
109 real(RP), intent(in) :: dom_xmin
110 real(RP), intent(in) :: dom_xmax
111 real(RP), intent(in) :: dom_ymin
112 real(RP), intent(in) :: dom_ymax
113 real(RP), intent(in) :: dom_Zmin
114 real(RP), intent(in) :: dom_zmax
115 logical, intent(in) :: isPeriodicX
116 logical, intent(in) :: isPeriodicY
117 logical, intent(in) :: isPeriodicZ
118 type(hexahedralelement), intent(in), target :: refElem
119 integer, intent(in) :: NLocalMeshPerPrc
120 integer, intent(in) :: NprcX
121 integer, intent(in) :: NprcY
122 integer, intent(in), optional :: nproc
123 integer, intent(in), optional :: myrank
124 real(RP), intent(in), optional :: FZ(NeGZ+1)
125
126 integer :: k
127 real(RP) :: dz
128 !-----------------------------------------------------------------------------
129
130 this%NeGX = negx
131 this%NeGY = negy
132 this%NeGZ = negz
133
134 this%xmin_gl = dom_xmin
135 this%xmax_gl = dom_xmax
136 this%ymin_gl = dom_ymin
137 this%ymax_gl = dom_ymax
138 this%zmin_gl = dom_zmin
139 this%zmax_gl = dom_zmax
140 this%dom_vol = (this%xmax_gl - this%xmin_gl) * (this%ymax_gl - this%ymin_gl) * (this%zmax_gl - this%zmin_gl)
141
142 this%isPeriodicX = isperiodicx
143 this%isPeriodicY = isperiodicy
144 this%isPeriodicZ = isperiodicz
145
146 this%NprcX = nprcx
147 this%NprcY = nprcy
148 this%NprcZ = 1
149
150 !- Fz
151 allocate( this%FZ(this%NeGZ+1) )
152 if ( present(fz) ) then
153 this%FZ(:) = fz(:)
154 else
155 this%FZ(1 ) = dom_zmin
156 this%FZ(this%NeGZ+1) = dom_zmax
157 dz = (dom_zmax - dom_zmin) / dble(this%NeGZ)
158 do k=2, this%NeGZ
159 this%FZ(k) = this%FZ(k-1) + dz
160 end do
161 end if
162
163 !--
164 call meshbase3d_init( this, refelem, nlocalmeshperprc, 6, &
165 nproc, myrank )
166
167 !--- 2D mesh
168
169 call this%refElem2D%Init( this%refElem3D%PolyOrder_h, refelem%IsLumpedMatrix() )
170
171 this%mesh2D%isPeriodicX = isperiodicx
172 this%mesh2D%isPeriodicY = isperiodicy
173 this%mesh2D%NprcX = nprcx
174 this%mesh2D%NprcY = nprcy
175
176 call meshbase2d_init( this%mesh2D, this%refElem2D, nlocalmeshperprc, &
177 nproc, myrank )
178
179 return
180 end subroutine meshcubedom3d_init
181
182!OCL SERIAL
183 subroutine meshcubedom3d_final( this )
184 use scale_prc
185 implicit none
186
187 class(meshcubedom3d), intent(inout) :: this
188 !-----------------------------------------------------------------------------
189
190 if (this%isGenerated) then
191 if ( allocated(this%rcdomIJK2LCMeshID) ) then
192 deallocate( this%rcdomIJK2LCMeshID )
193 end if
194 else
195 if ( allocated( this%FZ ) ) deallocate( this%FZ )
196 end if
197
198 call this%mesh2D%Final()
199 call this%refElem2D%Final()
200
201 call meshbase3d_final(this)
202
203 return
204 end subroutine meshcubedom3d_final
205
206!OCL SERIAL
207 subroutine meshcubedom3d_getmesh2d( this, ptr_mesh2D )
208 implicit none
209 class(meshcubedom3d), intent(in), target :: this
210 class(meshbase2d), pointer, intent(out) :: ptr_mesh2D
211 !-------------------------------------------------------
212
213 ptr_mesh2d => this%mesh2D
214 return
215 end subroutine meshcubedom3d_getmesh2d
216
217!OCL SERIAL
218 subroutine meshcubedom3d_generate( this )
219 implicit none
220
221 class(meshcubedom3d), intent(inout), target :: this
222
223 integer :: n
224 type(localmesh3d), pointer :: mesh
225
226 integer :: tileID_table(this%LOCAL_MESH_NUM, this%PRC_NUM)
227 integer :: panelID_table(this%LOCAL_MESH_NUM*this%PRC_NUM)
228 integer :: pi_table(this%LOCAL_MESH_NUM*this%PRC_NUM)
229 integer :: pj_table(this%LOCAL_MESH_NUM*this%PRC_NUM)
230 integer :: pk_table(this%LOCAL_MESH_NUM*this%PRC_NUM)
231
232 integer :: TILE_NUM_PER_PANEL
233 integer :: tileID
234 !-----------------------------------------------------------------------------
235
236 tile_num_per_panel = this%LOCAL_MESH_NUM_global / 1
237
238
239 !--- Construct the connectivity of patches (only master node)
240
241 call messhcubedom3d_assigndomid( this, & ! (in)
242 tileid_table, panelid_table, & ! (out)
243 pi_table, pj_table, pk_table ) ! (out)
244
245 !--- Setup local meshes managed by my process
246
247 do n=1, this%LOCAL_MESH_NUM
248 mesh => this%lcmesh_list(n)
249 tileid = tileid_table(n, mesh%PRC_myrank+1)
250
251 call meshcubedom3d_setuplocaldom( mesh, &
252 tileid, panelid_table(tileid), &
253 pi_table(tileid), pj_table(tileid), pk_table(tileid), this%NprcX, this%NprcY, this%NprcZ, &
254 this%xmin_gl, this%xmax_gl, this%ymin_gl, this%ymax_gl, this%zmin_gl, this%zmax_gl, &
255 this%NeGX/this%NprcX, this%NeGY/this%NprcY, this%NeGZ/this%NprcZ, this%FZ(:) )
256
257 call meshrectdom2d_setuplocaldom( this%mesh2D%lcmesh_list(n), &
258 tileid, panelid_table(tileid), &
259 pi_table(tileid), pj_table(tileid), this%NprcX, this%NprcY, &
260 this%xmin_gl, this%xmax_gl, this%ymin_gl, this%ymax_gl, &
261 this%NeGX/this%NprcX, this%NeGY/this%NprcY )
262
263 call mesh%SetLocalMesh2D( this%mesh2D%lcmesh_list(n) )
264 !---
265 ! write(*,*) "** my_rank=", mesh%PRC_myrank
266 ! write(*,*) " tileID:", mesh%tileID
267 ! write(*,*) " pnlID:", mesh%panelID, "-- i,j (within a panel)=", pi_table(tileID), pj_table(tileID)
268 ! write(*,*) " local mesh:", n, "( total", this%LOCAL_MESH_NUM, ")"
269 ! write(*,*) " panel_connect:", this%tilePanelID_globalMap(:,mesh%tileID)
270 ! write(*,*) " tile_connect:", this%tileID_globalMap(:,mesh%tileID)
271 ! write(*,*) " face_connect:", this%tileFaceID_globalMap(:,mesh%tileID)
272 ! write(*,*) " domain size"
273 ! write(*,*) " NeX, NeY:", mesh%NeX, mesh%NeY
274 ! write(*,*) " [X], [Y]:", mesh%xmin, mesh%xmax, ":", mesh%ymin, mesh%ymax
275 end do
276
277 ! To set rcdomIJP2LCMeshID, call AssignDomID for 2D mesh
278 call this%mesh2D%AssignDomID( &
279 tileid_table, panelid_table, & ! (out)
280 pi_table, pj_table ) ! (out)
281
282 this%isGenerated = .true.
283 this%mesh2D%isGenerated = .true.
284
285 deallocate( this%FZ )
286
287 return
288 end subroutine meshcubedom3d_generate
289
290!OCL SERIAL
291 subroutine meshcubedom3d_set_geometric_with_vcoord(this, lcdomID, GsqrtV_lc, zlev_lc, G13_lc, G23_lc)
292 implicit none
293 class(meshcubedom3d), intent(inout), target :: this
294 integer, intent(in) :: lcdomID
295 real(RP), intent(in) :: GsqrtV_lc(this%refElem3D%Np,this%lcmesh_list(lcdomID)%NeA)
296 real(RP), intent(in) :: zlev_lc(this%refElem3D%Np,this%lcmesh_list(lcdomID)%NeA)
297 real(RP), intent(in) :: G13_lc(this%refElem3D%Np,this%lcmesh_list(lcdomID)%NeA)
298 real(RP), intent(in) :: G23_lc(this%refElem3D%Np,this%lcmesh_list(lcdomID)%NeA)
299
300 integer :: ke
301 class(localmesh3d), pointer :: lcmesh
302 !-------------------------------------------------------
303
304 lcmesh => this%lcmesh_list(lcdomid)
305
306 !$omp parallel private(ke)
307 !$omp do
308 do ke=lcmesh%NeS, lcmesh%NeE
309 lcmesh%zlev(:,ke) = zlev_lc(:,ke)
310 end do
311 !$omp do
312 do ke=lcmesh%NeS, lcmesh%NeA
313 lcmesh%Gsqrt(:,ke) = gsqrtv_lc(:,ke)
314 lcmesh%GI3(:,ke,1) = g13_lc(:,ke)
315 lcmesh%GI3(:,ke,2) = g23_lc(:,ke)
316 end do
317 !$omp end parallel
318
319 return
320 end subroutine meshcubedom3d_set_geometric_with_vcoord
321
322 !- private ------------------------------------------------------
323
324!OCL SERIAL
325 subroutine meshcubedom3d_setuplocaldom( lcmesh, &
326 tileID, panelID, &
327 i, j, k, NprcX, NprcY, NprcZ, &
328 dom_xmin, dom_xmax, dom_ymin, dom_ymax, dom_zmin, dom_zmax, &
329 NeX, NeY, NeZ, &
330 FZ )
331
332 use scale_prof
333 use scale_meshutil_3d, only: &
338
340 implicit none
341
342 type(localmesh3d), intent(inout) :: lcmesh
343 integer, intent(in) :: tileID
344 integer, intent(in) :: panelID
345 integer, intent(in) :: i, j, k
346 integer, intent(in) :: NprcX, NprcY, NprcZ
347 real(RP), intent(in) :: dom_xmin, dom_xmax
348 real(RP), intent(in) :: dom_ymin, dom_ymax
349 real(RP), intent(in) :: dom_Zmin, dom_zmax
350 integer, intent(in) :: NeX, NeY, NeZ
351 real(RP), intent(in) :: FZ(NeZ*NprcZ+1)
352
353 class(elementbase3d), pointer :: elem
354 real(RP) :: delx, dely
355 real(RP) :: FZ_lc(NeZ+1)
356
357 integer :: ii, jj, kk
358 integer :: ke
359 !-----------------------------------------------------------------------------
360
361 elem => lcmesh%refElem3D
362 lcmesh%tileID = tileid
363 lcmesh%panelID = panelid
364
365 !--
366 lcmesh%Ne = nex * ney * nez
367 lcmesh%Nv = (nex + 1)*(ney + 1)*(nez + 1)
368 lcmesh%NeS = 1
369 lcmesh%NeE = lcmesh%Ne
370 lcmesh%NeA = lcmesh%Ne + 2*(nex + ney)*nez + 2*nex*ney
371
372 lcmesh%NeX = nex
373 lcmesh%NeY = ney
374 lcmesh%NeZ = nez
375
376 lcmesh%Ne2D = nex * ney
377 lcmesh%Ne2DA = nex * ney + 2*(nex + ney)
378
379 !--
380 delx = (dom_xmax - dom_xmin)/dble(nprcx)
381 dely = (dom_ymax - dom_ymin)/dble(nprcy)
382 fz_lc(:) = fz((k-1)*nez+1:k*nez+1)
383 lcmesh%xmin = dom_xmin + (i-1)*delx
384 lcmesh%xmax = dom_xmin + i *delx
385 lcmesh%ymin = dom_ymin + (j-1)*dely
386 lcmesh%ymax = dom_ymin + j *dely
387 lcmesh%zmin = fz_lc(1)
388 lcmesh%zmax = fz_lc(nez+1)
389
390 !-
391 allocate( lcmesh%pos_ev(lcmesh%Nv,3) )
392 allocate( lcmesh%EToV(lcmesh%Ne,elem%Nv) )
393 allocate( lcmesh%EToE(lcmesh%Ne,elem%Nfaces) )
394 allocate( lcmesh%EToF(lcmesh%Ne,elem%Nfaces) )
395 allocate( lcmesh%BCType(lcmesh%refElem%Nfaces,lcmesh%Ne) )
396 allocate( lcmesh%VMapM(elem%NfpTot, lcmesh%Ne) )
397 allocate( lcmesh%VMapP(elem%NfpTot, lcmesh%Ne) )
398 allocate( lcmesh%MapM(elem%NfpTot, lcmesh%Ne) )
399 allocate( lcmesh%MapP(elem%NfpTot, lcmesh%Ne) )
400
401 allocate( lcmesh%EMap3Dto2D(lcmesh%Ne) )
402
403 lcmesh%BCType(:,:) = bctype_interior
404
405 !----
406
407 call meshutil3d_gencubedomain( lcmesh%pos_ev, lcmesh%EToV, & ! (out)
408 lcmesh%NeX, lcmesh%xmin, lcmesh%xmax, & ! (in)
409 lcmesh%NeY, lcmesh%ymin, lcmesh%ymax, & ! (in)
410 lcmesh%NeZ, lcmesh%zmin, lcmesh%zmax, fz=fz_lc ) ! (in)
411
412 !---
413 call meshbase3d_setgeometricinfo( lcmesh, meshcubedom3d_coord_conv, meshcubedom3d_calc_normal )
414
415 !---
416 call meshutil3d_genconnectivity( lcmesh%EToE, lcmesh%EToF, & ! (out)
417 lcmesh%EToV, lcmesh%Ne, elem%Nfaces ) ! (in)
418
419 !---
420 call meshutil3d_buildinteriormap( lcmesh%VmapM, lcmesh%VMapP, lcmesh%MapM, lcmesh%MapP, & ! (out)
421 lcmesh%pos_en, lcmesh%pos_ev, lcmesh%EToE, lcmesh%EtoF, lcmesh%EtoV, & ! (in)
422 elem%Fmask_h, elem%Fmask_v, lcmesh%Ne, lcmesh%Nv, elem%Np, elem%Nfp_h, elem%Nfp_v, elem%NfpTot, & ! (in)
423 elem%Nfaces_h, elem%Nfaces_v, elem%Nfaces ) ! (in)
424
425 call meshutil3d_genpatchboundarymap( lcmesh%VMapB, lcmesh%MapB, lcmesh%VMapP, & !(out)
426 lcmesh%pos_en, lcmesh%xmin, lcmesh%xmax, lcmesh%ymin, lcmesh%ymax, lcmesh%zmin, lcmesh%zmax, & ! (in)
427 elem%Fmask_h, elem%Fmask_v, lcmesh%Ne, lcmesh%Nv, elem%Np, elem%Nfp_h, elem%Nfp_v, elem%NfpTot, & ! (in)
428 elem%Nfaces_h, elem%Nfaces_v, elem%Nfaces ) ! (in)
429
430 !---
431 !$omp parallel do collapse(2) private(ii,ke)
432 do kk=1, lcmesh%NeZ
433 do jj=1, lcmesh%NeY
434 do ii=1, lcmesh%NeX
435 ke = ii + (jj-1) * lcmesh%NeX + (kk-1) * lcmesh%NeX * lcmesh%NeY
436 lcmesh%EMap3Dto2D(ke) = ii + (jj-1) * lcmesh%NeX
437 end do
438 end do
439 end do
440
441 return
442 end subroutine meshcubedom3d_setuplocaldom
443
444!OCL SERIAL
445 subroutine messhcubedom3d_assigndomid( this, &
446 tileID_table, panelID_table, &
447 pi_table, pj_table, pk_table )
448
449 use scale_meshutil_3d, only: &
451 implicit none
452
453 type(meshcubedom3d), target, intent(inout) :: this
454 integer, intent(out) :: tileID_table(this%LOCAL_MESH_NUM, this%PRC_NUM)
455 integer, intent(out) :: panelID_table(this%LOCAL_MESH_NUM*this%PRC_NUM)
456 integer, intent(out) :: pi_table(this%LOCAL_MESH_NUM*this%PRC_NUM)
457 integer, intent(out) :: pj_table(this%LOCAL_MESH_NUM*this%PRC_NUM)
458 integer, intent(out) :: pk_table(this%LOCAL_MESH_NUM*this%PRC_NUM)
459
460 integer :: n
461 integer :: p
462 integer :: tileID
463 integer :: is_lc, js_lc, ks_lc
464 integer :: ilc_count, jlc_count, klc_count
465 integer :: ilc, jlc, klc
466
467 type(localmesh3d), pointer :: lcmesh
468 !-----------------------------------------------------------------------------
469
471 panelid_table, pi_table, pj_table, pk_table, & ! (out)
472 this%tileID_globalMap, this%tileFaceID_globalMap, this%tilePanelID_globalMap, & ! (out)
473 this%LOCAL_MESH_NUM_global, 6, 8, & ! (in)
474 this%isPeriodicX, this%isPeriodicY, this%isPeriodicZ, & ! (in)
475 this%NprcX, this%NprcY, this%NprcZ ) ! (in)
476
477 !----
478
479 do p=1, this%PRC_NUM
480 do n=1, this%LOCAL_MESH_NUM
481 tileid = n + (p-1)*this%LOCAL_MESH_NUM
482 lcmesh => this%lcmesh_list(n)
483 !-
484 tileid_table(n,p) = tileid
485 this%tileID_global2localMap(tileid) = n
486 this%PRCRank_globalMap(tileid) = p - 1
487
488 !-
489 if ( this%PRCRank_globalMap(tileid) == lcmesh%PRC_myrank ) then
490 if (n==1) then
491 is_lc = pi_table(tileid); ilc_count = 1
492 js_lc = pj_table(tileid); jlc_count = 1
493 ks_lc = pk_table(tileid); klc_count = 1
494 end if
495 if(is_lc < pi_table(tileid)) ilc_count = ilc_count + 1
496 if(js_lc < pj_table(tileid)) jlc_count = jlc_count + 1
497 if(ks_lc < pk_table(tileid)) klc_count = klc_count + 1
498 end if
499 end do
500 end do
501
502 allocate( this%rcdomIJK2LCMeshID(ilc_count,jlc_count,klc_count) )
503 do klc=1, klc_count
504 do jlc=1, jlc_count
505 do ilc=1, ilc_count
506 this%rcdomIJK2LCMeshID(ilc,jlc,klc) = ilc + (jlc - 1)*ilc_count + (klc - 1)*ilc_count*jlc_count
507 end do
508 end do
509 end do
510
511 return
512 end subroutine messhcubedom3d_assigndomid
513
514!OCL SERIAL
515 subroutine meshcubedom3d_coord_conv( x, y, z, xX, xY, xZ, yX, yY, yZ, zX, zY, zZ, &
516 vx, vy, vz, elem )
517
518 implicit none
519
520 type(elementbase3d), intent(in) :: elem
521 real(rp), intent(out) :: x(elem%np), y(elem%np), z(elem%np)
522 real(rp), intent(out) :: xx(elem%np), xy(elem%np), xz(elem%np)
523 real(rp), intent(out) :: yx(elem%np), yy(elem%np), yz(elem%np)
524 real(rp), intent(out) :: zx(elem%np), zy(elem%np), zz(elem%np)
525 real(rp), intent(in) :: vx(elem%nv), vy(elem%nv), vz(elem%nv)
526
527 !-------------------------------------------------
528
529 x(:) = vx(1) + 0.5_rp*(elem%x1(:) + 1.0_rp)*(vx(2) - vx(1))
530 y(:) = vy(1) + 0.5_rp*(elem%x2(:) + 1.0_rp)*(vy(3) - vy(1))
531 z(:) = vz(1) + 0.5_rp*(elem%x3(:) + 1.0_rp)*(vz(5) - vz(1))
532
533 xx(:) = 0.5_rp*(vx(2) - vx(1)) !matmul(refElem%Dx1,mesh%x1(:,n))
534 xy(:) = 0.0_rp !matmul(refElem%Dx2,mesh%x1(:,n))
535 xz(:) = 0.0_rp !matmul(refElem%Dx3,mesh%x1(:,n))
536 yx(:) = 0.0_rp !matmul(refElem%Dx1,mesh%x2(:,n))
537 yy(:) = 0.5_rp*(vy(3) - vy(1)) !matmul(refElem%Dx2,mesh%x2(:,n))
538 yz(:) = 0.0_rp !matmul(refElem%Dx3,mesh%x2(:,n))
539 zx(:) = 0.0_rp !matmul(refElem%Dx1,mesh%x3(:,n))
540 zy(:) = 0.0_rp !matmul(refElem%Dx2,mesh%x3(:,n))
541 zz(:) = 0.5_rp*(vz(5) - vz(1)) !matmul(refElem%Dx3,mesh%x3(:,n))
542
543 return
544 end subroutine meshcubedom3d_coord_conv
545
546!OCL SERIAL
547 subroutine meshcubedom3d_calc_normal( normal_fn, &
548 Escale_f, fid_h, fid_v, elem )
549
550 implicit none
551
552 type(elementbase3d), intent(in) :: elem
553 real(rp), intent(out) :: normal_fn(elem%nfptot,3)
554 integer, intent(in) :: fid_h(elem%nfp_h,elem%nfaces_h)
555 integer, intent(in) :: fid_v(elem%nfp_v,elem%nfaces_v)
556 real(rp), intent(in) :: escale_f(elem%nfptot,3,3)
557
558 integer :: d
559 !-------------------------------------------------
560
561 do d=1, 3
562 normal_fn(fid_h(:,1),d) = - escale_f(fid_h(:,1),2,d)
563 normal_fn(fid_h(:,2),d) = + escale_f(fid_h(:,2),1,d)
564 normal_fn(fid_h(:,3),d) = + escale_f(fid_h(:,3),2,d)
565 normal_fn(fid_h(:,4),d) = - escale_f(fid_h(:,4),1,d)
566
567 normal_fn(fid_v(:,1),d) = - escale_f(fid_v(:,1),3,d)
568 normal_fn(fid_v(:,2),d) = + escale_f(fid_v(:,2),3,d)
569 end do
570
571 return
572 end subroutine meshcubedom3d_calc_normal
573
574end module scale_mesh_cubedom3d
module FElib / Element / Base
module FElib / Element / hexahedron
module FElib / Element / Quadrilateral
module FElib / Mesh / Local 3D
module FElib / Mesh / Local, Base
integer, parameter, public bctype_interior
module FElib / Mesh / Base 2D
subroutine, public meshbase2d_final(this)
subroutine, public meshbase2d_init(this, refelem, nlocalmeshperprc, nprocs, myrank)
subroutine, public meshbase2d_setgeometricinfo(lcmesh, coord_conv, calc_normal)
module FElib / Mesh / Base 3D
subroutine, public meshbase3d_init(this, refelem, nlocalmeshperprc, nsidetile, nproc, myrank)
subroutine, public meshbase3d_final(this)
subroutine, public meshbase3d_setgeometricinfo(lcmesh, coord_conv, calc_normal)
module FElib / Mesh / Cubic 3D domain
subroutine meshcubedom3d_init(this, negx, negy, negz, dom_xmin, dom_xmax, dom_ymin, dom_ymax, dom_zmin, dom_zmax, isperiodicx, isperiodicy, isperiodicz, refelem, nlocalmeshperprc, nprcx, nprcy, nproc, myrank, fz)
subroutine, public meshcubedom3d_coord_conv(x, y, z, xx, xy, xz, yx, yy, yz, zx, zy, zz, vx, vy, vz, elem)
module FElib / Mesh / Rectangle 2D domain
subroutine, public meshrectdom2d_setuplocaldom(lcmesh, tileid, panelid, i, j, nprcx, nprcy, dom_xmin, dom_xmax, dom_ymin, dom_ymax, nex, ney)
module FElib / Mesh / utility for 3D mesh
subroutine, public meshutil3d_buildglobalmap(panelid_table, pi_table, pj_table, pk_table, tileid_map, tilefaceid_map, tilepanelid_map, ntile, ntileface, ntilevertex, isperiodicx, isperiodicy, isperiodicz, ne_x, ne_y, ne_z)
subroutine, public meshutil3d_buildinteriormap(vmapm, vmapp, mapm, mapp, pos_en, pos_ev, etoe, etof, etov, fmask_h, fmask_v, ne, nv, np, nfp_h, nfp_v, nfptot, nfaces_h, nfaces_v, nfaces)
subroutine, public meshutil3d_genconnectivity(etoe, etof, etov, ne, nfaces)
subroutine, public meshutil3d_gencubedomain(pos_v, etov, ke_x, xmin, xmax, ke_y, ymin, ymax, ke_z, zmin, zmax, fz)
subroutine, public meshutil3d_genpatchboundarymap(vmapb, mapb, vmapp, pos_en, xmin, xmax, ymin, ymax, zmin, zmax, fmask_h, fmask_v, ne, nv, np, nfp_h, nfp_v, nfptot, nfaces_h, nfaces_v, nfaces)