54 real(rp),
public :: xmin_gl, xmax_gl
55 real(rp),
public :: ymin_gl, ymax_gl
56 real(rp),
public :: zmin_gl, zmax_gl
58 real(rp),
allocatable :: fz(:)
60 integer,
allocatable :: rcdomijk2lcmeshid(:,:,:)
62 logical :: isperiodicx
63 logical :: isperiodicy
64 logical :: isperiodicz
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
97 dom_xmin, dom_xmax, dom_ymin, dom_ymax, dom_zmin, dom_zmax, &
98 isPeriodicX, isPeriodicY, isPeriodicZ, &
99 refElem, NLocalMeshPerPrc, NprcX, NprcY, &
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
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)
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)
142 this%isPeriodicX = isperiodicx
143 this%isPeriodicY = isperiodicy
144 this%isPeriodicZ = isperiodicz
151 allocate( this%FZ(this%NeGZ+1) )
152 if (
present(fz) )
then
155 this%FZ(1 ) = dom_zmin
156 this%FZ(this%NeGZ+1) = dom_zmax
157 dz = (dom_zmax - dom_zmin) / dble(this%NeGZ)
159 this%FZ(k) = this%FZ(k-1) + dz
169 call this%refElem2D%Init( this%refElem3D%PolyOrder_h, refelem%IsLumpedMatrix() )
171 this%mesh2D%isPeriodicX = isperiodicx
172 this%mesh2D%isPeriodicY = isperiodicy
173 this%mesh2D%NprcX = nprcx
174 this%mesh2D%NprcY = nprcy
183 subroutine meshcubedom3d_final( this )
190 if (this%isGenerated)
then
191 if (
allocated(this%rcdomIJK2LCMeshID) )
then
192 deallocate( this%rcdomIJK2LCMeshID )
195 if (
allocated( this%FZ ) )
deallocate( this%FZ )
198 call this%mesh2D%Final()
199 call this%refElem2D%Final()
204 end subroutine meshcubedom3d_final
207 subroutine meshcubedom3d_getmesh2d( this, ptr_mesh2D )
210 class(
meshbase2d),
pointer,
intent(out) :: ptr_mesh2D
213 ptr_mesh2d => this%mesh2D
215 end subroutine meshcubedom3d_getmesh2d
218 subroutine meshcubedom3d_generate( this )
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)
232 integer :: TILE_NUM_PER_PANEL
236 tile_num_per_panel = this%LOCAL_MESH_NUM_global / 1
241 call messhcubedom3d_assigndomid( this, &
242 tileid_table, panelid_table, &
243 pi_table, pj_table, pk_table )
247 do n=1, this%LOCAL_MESH_NUM
248 mesh => this%lcmesh_list(n)
249 tileid = tileid_table(n, mesh%PRC_myrank+1)
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(:) )
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 )
263 call mesh%SetLocalMesh2D( this%mesh2D%lcmesh_list(n) )
278 call this%mesh2D%AssignDomID( &
279 tileid_table, panelid_table, &
282 this%isGenerated = .true.
283 this%mesh2D%isGenerated = .true.
285 deallocate( this%FZ )
288 end subroutine meshcubedom3d_generate
291 subroutine meshcubedom3d_set_geometric_with_vcoord(this, lcdomID, GsqrtV_lc, zlev_lc, G13_lc, G23_lc)
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)
304 lcmesh => this%lcmesh_list(lcdomid)
308 do ke=lcmesh%NeS, lcmesh%NeE
309 lcmesh%zlev(:,ke) = zlev_lc(:,ke)
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)
320 end subroutine meshcubedom3d_set_geometric_with_vcoord
325 subroutine meshcubedom3d_setuplocaldom( lcmesh, &
327 i, j, k, NprcX, NprcY, NprcZ, &
328 dom_xmin, dom_xmax, dom_ymin, dom_ymax, dom_zmin, dom_zmax, &
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)
354 real(RP) :: delx, dely
355 real(RP) :: FZ_lc(NeZ+1)
357 integer :: ii, jj, kk
361 elem => lcmesh%refElem3D
362 lcmesh%tileID = tileid
363 lcmesh%panelID = panelid
366 lcmesh%Ne = nex * ney * nez
367 lcmesh%Nv = (nex + 1)*(ney + 1)*(nez + 1)
369 lcmesh%NeE = lcmesh%Ne
370 lcmesh%NeA = lcmesh%Ne + 2*(nex + ney)*nez + 2*nex*ney
376 lcmesh%Ne2D = nex * ney
377 lcmesh%Ne2DA = nex * ney + 2*(nex + ney)
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)
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) )
401 allocate( lcmesh%EMap3Dto2D(lcmesh%Ne) )
408 lcmesh%NeX, lcmesh%xmin, lcmesh%xmax, &
409 lcmesh%NeY, lcmesh%ymin, lcmesh%ymax, &
410 lcmesh%NeZ, lcmesh%zmin, lcmesh%zmax, fz=fz_lc )
417 lcmesh%EToV, lcmesh%Ne, elem%Nfaces )
421 lcmesh%pos_en, lcmesh%pos_ev, lcmesh%EToE, lcmesh%EtoF, lcmesh%EtoV, &
422 elem%Fmask_h, elem%Fmask_v, lcmesh%Ne, lcmesh%Nv, elem%Np, elem%Nfp_h, elem%Nfp_v, elem%NfpTot, &
423 elem%Nfaces_h, elem%Nfaces_v, elem%Nfaces )
426 lcmesh%pos_en, lcmesh%xmin, lcmesh%xmax, lcmesh%ymin, lcmesh%ymax, lcmesh%zmin, lcmesh%zmax, &
427 elem%Fmask_h, elem%Fmask_v, lcmesh%Ne, lcmesh%Nv, elem%Np, elem%Nfp_h, elem%Nfp_v, elem%NfpTot, &
428 elem%Nfaces_h, elem%Nfaces_v, elem%Nfaces )
435 ke = ii + (jj-1) * lcmesh%NeX + (kk-1) * lcmesh%NeX * lcmesh%NeY
436 lcmesh%EMap3Dto2D(ke) = ii + (jj-1) * lcmesh%NeX
442 end subroutine meshcubedom3d_setuplocaldom
445 subroutine messhcubedom3d_assigndomid( this, &
446 tileID_table, panelID_table, &
447 pi_table, pj_table, pk_table )
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)
463 integer :: is_lc, js_lc, ks_lc
464 integer :: ilc_count, jlc_count, klc_count
465 integer :: ilc, jlc, klc
471 panelid_table, pi_table, pj_table, pk_table, &
472 this%tileID_globalMap, this%tileFaceID_globalMap, this%tilePanelID_globalMap, &
473 this%LOCAL_MESH_NUM_global, 6, 8, &
474 this%isPeriodicX, this%isPeriodicY, this%isPeriodicZ, &
475 this%NprcX, this%NprcY, this%NprcZ )
480 do n=1, this%LOCAL_MESH_NUM
481 tileid = n + (p-1)*this%LOCAL_MESH_NUM
482 lcmesh => this%lcmesh_list(n)
484 tileid_table(n,p) = tileid
485 this%tileID_global2localMap(tileid) = n
486 this%PRCRank_globalMap(tileid) = p - 1
489 if ( this%PRCRank_globalMap(tileid) == lcmesh%PRC_myrank )
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
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
502 allocate( this%rcdomIJK2LCMeshID(ilc_count,jlc_count,klc_count) )
506 this%rcdomIJK2LCMeshID(ilc,jlc,klc) = ilc + (jlc - 1)*ilc_count + (klc - 1)*ilc_count*jlc_count
512 end subroutine messhcubedom3d_assigndomid
515 subroutine meshcubedom3d_coord_conv( x, y, z, xX, xY, xZ, yX, yY, yZ, zX, zY, zZ, &
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)
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))
533 xx(:) = 0.5_rp*(vx(2) - vx(1))
537 yy(:) = 0.5_rp*(vy(3) - vy(1))
541 zz(:) = 0.5_rp*(vz(5) - vz(1))
547 subroutine meshcubedom3d_calc_normal( normal_fn, &
548 Escale_f, fid_h, fid_v, 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)
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)
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)
572 end subroutine meshcubedom3d_calc_normal
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)