10#include "scaleFElib.h"
43 real(rp),
public :: xmin_gl, xmax_gl
44 real(rp),
public :: ymin_gl, ymax_gl
45 integer,
allocatable :: rcdomij2lcmeshid(:,:)
47 logical :: isperiodicx
48 logical :: isperiodicy
51 procedure :: final => meshrectdom2d_final
52 procedure :: generate => meshrectdom2d_generate
53 procedure :: assigndomid => meshrectdom2d_assigndomid
77 dom_xmin, dom_xmax, dom_ymin, dom_ymax, &
78 isPeriodicX, isPeriodicY, &
79 refElem, NLocalMeshPerPrc, &
86 integer,
intent(in) :: NeGX
87 integer,
intent(in) :: NeGY
88 real(RP),
intent(in) :: dom_xmin
89 real(RP),
intent(in) :: dom_xmax
90 real(RP),
intent(in) :: dom_ymin
91 real(RP),
intent(in) :: dom_ymax
92 logical,
intent(in) :: isPeriodicX
93 logical,
intent(in) :: isPeriodicY
95 integer,
intent(in) :: NLocalMeshPerPrc
96 integer,
intent(in) :: NprcX
97 integer,
intent(in) :: NprcY
98 integer,
intent(in),
optional :: nproc
99 integer,
intent(in),
optional :: myrank
106 this%xmin_gl = dom_xmin
107 this%xmax_gl = dom_xmax
108 this%ymin_gl = dom_ymin
109 this%ymax_gl = dom_ymax
110 this%dom_vol = (this%xmax_gl - this%xmin_gl) * (this%ymax_gl - this%ymin_gl)
112 this%isPeriodicX = isperiodicx
113 this%isPeriodicY = isperiodicy
124 subroutine meshrectdom2d_final( this )
132 if (this%isGenerated)
then
133 if (
allocated(this%rcdomIJ2LCMeshID) )
then
134 deallocate( this%rcdomIJ2LCMeshID )
141 end subroutine meshrectdom2d_final
143 subroutine meshrectdom2d_generate( this )
153 integer :: tileID_table(this%LOCAL_MESH_NUM, this%PRC_NUM)
154 integer :: panelID_table(this%LOCAL_MESH_NUM*this%PRC_NUM)
155 integer :: pi_table(this%LOCAL_MESH_NUM*this%PRC_NUM)
156 integer :: pj_table(this%LOCAL_MESH_NUM*this%PRC_NUM)
158 integer :: TILE_NUM_PER_PANEL
159 real(RP) :: delx, dely
164 tile_num_per_panel = this%LOCAL_MESH_NUM_global / 1
169 call this%AssignDomID( &
170 tileid_table, panelid_table, &
175 do n=1, this%LOCAL_MESH_NUM
176 mesh => this%lcmesh_list(n)
177 tileid = tileid_table(n, mesh%PRC_myrank+1)
180 tileid, panelid_table(tileid), &
181 pi_table(tileid), pj_table(tileid), this%NprcX, this%NprcY, &
182 this%xmin_gl, this%xmax_gl, this%ymin_gl, this%ymax_gl, &
183 this%NeGX/this%NprcX, this%NeGY/this%NprcY )
198 this%isGenerated = .true.
201 end subroutine meshrectdom2d_generate
207 i, j, NprcX, NprcY, &
208 dom_xmin, dom_xmax, dom_ymin, dom_ymax, &
221 integer,
intent(in) :: tileid
222 integer,
intent(in) :: panelid
223 integer,
intent(in) :: i, j
224 integer,
intent(in) :: nprcx, nprcy
225 real(rp),
intent(in) :: dom_xmin, dom_xmax
226 real(rp),
intent(in) :: dom_ymin, dom_ymax
227 integer,
intent(in) ::nex, ney
230 real(rp) :: delx, dely
234 elem => lcmesh%refElem2D
235 lcmesh%tileID = tileid
236 lcmesh%panelID = panelid
240 lcmesh%Ne = nex * ney
241 lcmesh%Nv = (nex + 1)*(ney + 1)
243 lcmesh%NeE = lcmesh%Ne
244 lcmesh%NeA = lcmesh%Ne + 2*(nex + ney)
249 delx = (dom_xmax - dom_xmin)/dble(nprcx)
250 dely = (dom_ymax - dom_ymin)/dble(nprcy)
252 lcmesh%xmin = dom_xmin + (i-1)*delx
253 lcmesh%xmax = dom_xmin + i *delx
254 lcmesh%ymin = dom_ymin + (j-1)*dely
255 lcmesh%ymax = dom_ymin + j *dely
257 allocate( lcmesh%pos_ev(lcmesh%Nv,2) )
258 allocate( lcmesh%EToV(lcmesh%Ne,elem%Nv) )
259 allocate( lcmesh%EToE(lcmesh%Ne,elem%Nfaces) )
260 allocate( lcmesh%EToF(lcmesh%Ne,elem%Nfaces) )
261 allocate( lcmesh%BCType(lcmesh%refElem%Nfaces,lcmesh%Ne) )
262 allocate( lcmesh%VMapM(elem%NfpTot, lcmesh%Ne) )
263 allocate( lcmesh%VMapP(elem%NfpTot, lcmesh%Ne) )
264 allocate( lcmesh%MapM(elem%NfpTot, lcmesh%Ne) )
265 allocate( lcmesh%MapP(elem%NfpTot, lcmesh%Ne) )
272 lcmesh%NeX, lcmesh%xmin, lcmesh%xmax, &
273 lcmesh%NeY, lcmesh%ymin, lcmesh%ymax )
281 lcmesh%EToV, lcmesh%Ne, elem%Nfaces )
285 lcmesh%pos_en, lcmesh%pos_ev, lcmesh%EToE, lcmesh%EtoF, lcmesh%EtoV, &
286 elem%Fmask, lcmesh%Ne, elem%Np, elem%Nfp, elem%Nfaces, lcmesh%Nv )
289 lcmesh%pos_en, lcmesh%xmin, lcmesh%xmax, lcmesh%ymin, lcmesh%ymax, &
290 elem%Fmask, lcmesh%Ne, elem%Np, elem%Nfp, elem%Nfaces, lcmesh%Nv)
295 subroutine meshrectdom2d_assigndomid( this, &
296 tileID_table, panelID_table, &
305 integer,
intent(out) :: tileid_table(this%local_mesh_num, this%prc_num)
306 integer,
intent(out) :: panelid_table(this%local_mesh_num*this%prc_num)
307 integer,
intent(out) :: pi_table(this%local_mesh_num*this%prc_num)
308 integer,
intent(out) :: pj_table(this%local_mesh_num*this%prc_num)
313 integer :: is_lc, js_lc
314 integer :: ilc_count, jlc_count
321 panelid_table, pi_table, pj_table, &
322 this%tileID_globalMap, this%tileFaceID_globalMap, this%tilePanelID_globalMap, &
323 this%LOCAL_MESH_NUM_global, this%isPeriodicX, this%isPeriodicY, &
324 this%NprcX, this%NprcY )
328 do prc=1, this%PRC_NUM
329 do n=1, this%LOCAL_MESH_NUM
330 tileid = n + (prc-1)*this%LOCAL_MESH_NUM
331 lcmesh => this%lcmesh_list(n)
333 tileid_table(n,prc) = tileid
334 this%tileID_global2localMap(tileid) = n
335 this%PRCRank_globalMap(tileid) = prc - 1
338 if ( this%PRCRank_globalMap(tileid) == lcmesh%PRC_myrank )
then
340 is_lc = pi_table(tileid); ilc_count = 1
341 js_lc = pj_table(tileid); jlc_count = 1
343 if(is_lc < pi_table(tileid)) ilc_count = ilc_count + 1
344 if(js_lc < pj_table(tileid)) jlc_count = jlc_count + 1
349 allocate( this%rcdomIJ2LCMeshID(ilc_count,jlc_count) )
352 this%rcdomIJ2LCMeshID(ilc,jlc) = ilc + (jlc - 1)*ilc_count
357 end subroutine meshrectdom2d_assigndomid
365 real(rp),
intent(out) :: x(elem%np), y(elem%np)
366 real(rp),
intent(out) :: xr(elem%np), xs(elem%np), yr(elem%np), ys(elem%np)
367 real(rp),
intent(in) :: vx(elem%nv), vy(elem%nv)
371 x(:) = vx(1) + 0.5_rp*(elem%x1(:) + 1.0_rp)*(vx(2) - vx(1))
372 y(:) = vy(1) + 0.5_rp*(elem%x2(:) + 1.0_rp)*(vy(3) - vy(1))
374 xr(:) = 0.5_rp*(vx(2) - vx(1))
377 ys(:) = 0.5_rp*(vy(3) - vy(1))
382 subroutine meshrectdom2d_calc_normal( normal_fn, &
383 Escale_f, fid, elem )
388 real(rp),
intent(out) :: normal_fn(elem%nfptot,2)
389 integer,
intent(in) :: fid(elem%nfp,elem%nfaces)
390 real(rp),
intent(in) :: escale_f(elem%nfptot,2,2)
396 normal_fn(fid(:,1),d) = - escale_f(fid(:,1),2,d)
397 normal_fn(fid(:,2),d) = + escale_f(fid(:,2),1,d)
398 normal_fn(fid(:,3),d) = + escale_f(fid(:,3),2,d)
399 normal_fn(fid(:,4),d) = - escale_f(fid(:,4),1,d)
403 end subroutine meshrectdom2d_calc_normal
module FElib / Element / Base
module FElib / Element / Quadrilateral
module FElib / Mesh / Local 2D
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 / Rectangle 2D domain
subroutine, public meshrectdom2d_setuplocaldom(lcmesh, tileid, panelid, i, j, nprcx, nprcy, dom_xmin, dom_xmax, dom_ymin, dom_ymax, nex, ney)
subroutine, public meshrectdom2d_coord_conv(x, y, xr, xs, yr, ys, vx, vy, elem)
subroutine meshrectdom2d_init(this, negx, negy, dom_xmin, dom_xmax, dom_ymin, dom_ymax, isperiodicx, isperiodicy, refelem, nlocalmeshperprc, nprcx, nprcy, nproc, myrank)
module FElib / Mesh / utility for 2D mesh
subroutine, public meshutil2d_buildinteriormap(vmapm, vmapp, mapm, mapp, pos_en, pos_ev, etoe, etof, etov, fmask, ne, np, nfp, nfaces, nv)
subroutine, public meshutil2d_genconnectivity(etoe, etof, etov, ne, nfaces)
subroutine, public meshutil2d_genrectdomain(pos_v, etov, ke_x, xmin, xmax, ke_y, ymin, ymax)
subroutine, public meshutil2d_buildglobalmap(panelid_table, pi_table, pj_table, tileid_map, tilefaceid_map, tilepanelid_map, ntile, isperiodicx, isperiodicy, ne_x, ne_y)
subroutine, public meshutil2d_genpatchboundarymap(vmapb, mapb, vmapp, pos_en, xmin, xmax, ymin, ymax, fmask, ne, np, nfp, nfaces, nv)