FE-Project
Loading...
Searching...
No Matches
Data Types | Functions/Subroutines | Variables
scale_mesh_base3d Module Reference

module FElib / Mesh / Base 3D More...

Data Types

type  meshbase3d
 
interface  meshbase3d_generate
 

Functions/Subroutines

subroutine, public meshbase3d_init (this, refelem, nlocalmeshperprc, nsidetile, nproc, myrank)
 
subroutine, public meshbase3d_final (this)
 
subroutine, public meshbase3d_setgeometricinfo (lcmesh, coord_conv, calc_normal)
 

Variables

integer, public meshbase3d_dimtype_num = 8
 
integer, public meshbase3d_dimtypeid_x = 1
 
integer, public meshbase3d_dimtypeid_y = 2
 
integer, public meshbase3d_dimtypeid_z = 3
 
integer, public meshbase3d_dimtypeid_zt = 4
 
integer, public meshbase3d_dimtypeid_xy = 5
 
integer, public meshbase3d_dimtypeid_xyt = 6
 
integer, public meshbase3d_dimtypeid_xyz = 7
 
integer, public meshbase3d_dimtypeid_xyzt = 8
 

Detailed Description

module FElib / Mesh / Base 3D

Description
Base module to manage 3D meshes for element-based methods
Author
Yuta Kawai, Team SCALE

Function/Subroutine Documentation

◆ meshbase3d_init()

subroutine, public scale_mesh_base3d::meshbase3d_init ( class(meshbase3d), intent(inout) this,
class(elementbase3d), intent(in), target refelem,
integer, intent(in) nlocalmeshperprc,
integer, intent(in) nsidetile,
integer, intent(in), optional nproc,
integer, intent(in), optional myrank )

Definition at line 100 of file scale_mesh_base3d.F90.

103
104 implicit none
105
106 class(MeshBase3D), intent(inout) :: this
107 class(ElementBase3D), intent(in), target :: refElem
108 integer, intent(in) :: NLocalMeshPerPrc
109 integer, intent(in) :: NsideTile
110 integer, intent(in), optional :: nproc
111 integer, intent(in), optional :: myrank
112
113 integer :: n
114 !-----------------------------------------------------------------------------
115
116 this%refElem3D => refelem
117 call meshbase_init( this, &
118 meshbase3d_dimtype_num, refelem, &
119 nlocalmeshperprc, nsidetile, nproc )
120
121 allocate( this%lcmesh_list(this%LOCAL_MESH_NUM) )
122 do n=1, this%LOCAL_MESH_NUM
123 call localmesh3d_init( this%lcmesh_list(n), n, refelem, myrank )
124 end do
125
126 call this%SetDimInfo( meshbase3d_dimtypeid_x, "x", "m", "X-coordinate" )
127 call this%SetDimInfo( meshbase3d_dimtypeid_y, "y", "m", "Y-coordinate" )
128 call this%SetDimInfo( meshbase3d_dimtypeid_z, "z", "m", "Z-coordinate" )
129 call this%SetDimInfo( meshbase3d_dimtypeid_zt, "z", "m", "Z-coordinate" )
130 call this%SetDimInfo( meshbase3d_dimtypeid_xy, "xy", "m", "XY-coordinate" )
131 call this%SetDimInfo( meshbase3d_dimtypeid_xyt, "xyt", "m", "XY-coordinate" )
132 call this%SetDimInfo( meshbase3d_dimtypeid_xyz, "xyz", "m", "XYZ-coordinate" )
133 call this%SetDimInfo( meshbase3d_dimtypeid_xyzt, "xyzt", "m", "XYZ-coordinate" )
134
135 return

References scale_localmesh_3d::localmesh3d_init(), meshbase3d_dimtype_num, meshbase3d_dimtypeid_x, meshbase3d_dimtypeid_xy, meshbase3d_dimtypeid_xyt, meshbase3d_dimtypeid_xyz, meshbase3d_dimtypeid_xyzt, meshbase3d_dimtypeid_y, meshbase3d_dimtypeid_z, meshbase3d_dimtypeid_zt, and scale_mesh_base::meshbase_init().

Referenced by scale_mesh_base3d::meshbase3d_generate::meshbase3d_generate(), scale_mesh_cubedom3d::meshcubedom3d_init(), and scale_mesh_cubedspheredom3d::meshcubedspheredom3d_init().

◆ meshbase3d_final()

subroutine, public scale_mesh_base3d::meshbase3d_final ( class(meshbase3d), intent(inout) this)

Definition at line 139 of file scale_mesh_base3d.F90.

140 implicit none
141 class(MeshBase3D), intent(inout) :: this
142
143 integer :: n
144 !-----------------------------------------------------------------------------
145
146 if ( allocated ( this%lcmesh_list ) ) then
147 do n=1, this%LOCAL_MESH_NUM
148 call localmesh3d_final( this%lcmesh_list(n), this%isGenerated )
149 end do
150
151 deallocate( this%lcmesh_list )
152 end if
153
154 call meshbase_final(this)
155
156 return

References scale_localmesh_3d::localmesh3d_final(), and scale_mesh_base::meshbase_final().

Referenced by scale_mesh_base3d::meshbase3d_generate::meshbase3d_generate(), scale_mesh_cubedom3d::meshcubedom3d_init(), and scale_mesh_cubedspheredom3d::meshcubedspheredom3d_init().

◆ meshbase3d_setgeometricinfo()

subroutine, public scale_mesh_base3d::meshbase3d_setgeometricinfo ( type(localmesh3d), intent(inout) lcmesh,
external subroutine(real(rp), dimension(elem%np), intent(out) x, real(rp), dimension(elem%np), intent(out) y, real(rp), dimension(elem%np), intent(out) z, real(rp), dimension(elem%np), intent(out) xx, real(rp), dimension(elem%np), intent(out) xy, real(rp), dimension(elem%np), intent(out) xz, real(rp), dimension(elem%np), intent(out) yx, real(rp), dimension(elem%np), intent(out) yy, real(rp), dimension(elem%np), intent(out) yz, real(rp), dimension(elem%np), intent(out) zx, real(rp), dimension(elem%np), intent(out) zy, real(rp), dimension(elem%np), intent(out) zz, real(rp), dimension(elem%nv), intent(in) vx, real(rp), dimension(elem%nv), intent(in) vy, real(rp), dimension(elem%nv), intent(in) vz, type(elementbase3d), intent(in) elem) coord_conv,
external subroutine(real(rp), dimension(elem%nfptot,3), intent(out) normal_fn, real(rp), dimension(elem%nfptot,3,3), intent(in) escale_f, integer, dimension(elem%nfp_h,elem%nfaces_h), intent(in) fid_h, integer, dimension(elem%nfp_v,elem%nfaces_v), intent(in) fid_v, type(elementbase3d), intent(in) elem) calc_normal )

Definition at line 174 of file scale_mesh_base3d.F90.

175 implicit none
176
177 type(LocalMesh3D), intent(inout) :: lcmesh
178 interface
179 subroutine coord_conv( x, y, z, xX, xY, xZ, yX, yY, yZ, zX, zY, zZ, &
180 vx, vy, vz, elem )
181 import elementbase3d
182 import rp
183 type(ElementBase3D), intent(in) :: elem
184 real(RP), intent(out) :: x(elem%Np), y(elem%Np), z(elem%Np)
185 real(RP), intent(out) :: xX(elem%Np), xY(elem%Np), xZ(elem%Np)
186 real(RP), intent(out) :: yX(elem%Np), yY(elem%Np), yZ(elem%Np)
187 real(RP), intent(out) :: zX(elem%Np), zY(elem%Np), zZ(elem%Np)
188 real(RP), intent(in) :: vx(elem%Nv), vy(elem%Nv), vz(elem%Nv)
189 end subroutine coord_conv
190 subroutine calc_normal( normal_fn, &
191 Escale_f, fid_h, fid_v, elem )
192 import elementbase3d
193 import rp
194 type(ElementBase3D), intent(in) :: elem
195 real(RP), intent(out) :: normal_fn(elem%NfpTot,3)
196 integer, intent(in) :: fid_h(elem%Nfp_h,elem%Nfaces_h)
197 integer, intent(in) :: fid_v(elem%Nfp_v,elem%Nfaces_v)
198 real(RP), intent(in) :: Escale_f(elem%NfpTot,3,3)
199 end subroutine calc_normal
200 end interface
201
202 class(ElementBase3D), pointer :: refElem
203 integer :: ke, ke2D
204 integer :: f
205 integer :: i, j
206 integer :: d
207 integer :: fmask(lcmesh%refElem%NfpTot)
208 integer :: fid_h(lcmesh%refElem3D%Nfp_h,lcmesh%refElem3D%Nfaces_h)
209 integer :: fid_v(lcmesh%refElem3D%Nfp_v,lcmesh%refElem3D%Nfaces_v)
210 real(RP) :: Escale_f(lcmesh%refElem%NfpTot,3,3)
211
212 integer :: node_ids(lcmesh%refElem%Nv)
213 real(RP) :: vx(lcmesh%refElem%Nv), vy(lcmesh%refElem%Nv), vz(lcmesh%refElem%Nv)
214 real(RP) :: xX(lcmesh%refElem%Np), xY(lcmesh%refElem%Np), xZ(lcmesh%refElem%Np)
215 real(RP) :: yX(lcmesh%refElem%Np), yY(lcmesh%refElem%Np), yZ(lcmesh%refElem%Np)
216 real(RP) :: zX(lcmesh%refElem%Np), zY(lcmesh%refElem%Np), zZ(lcmesh%refElem%Np)
217 !-----------------------------------------------------------------------------
218
219 refelem => lcmesh%refElem3D
220
221 allocate( lcmesh%pos_en(refelem%Np,lcmesh%Ne,3) )
222 !allocate( mesh%fx(refElem%Nfaces*refElem%Nfp,mesh%Ne) )
223 !allocate( mesh%fy(refElem%Nfaces*refElem%Nfp,mesh%Ne) )
224 allocate( lcmesh%normal_fn(refelem%NfpTot,lcmesh%Ne,3) )
225 allocate( lcmesh%sJ(refelem%NfpTot,lcmesh%Ne) )
226 allocate( lcmesh%J(refelem%Np,lcmesh%Ne) )
227 allocate( lcmesh%Fscale(refelem%NfpTot,lcmesh%Ne) )
228 allocate( lcmesh%Escale(refelem%Np,lcmesh%Ne,3,3) )
229 allocate( lcmesh%zS(refelem%Np,lcmesh%Ne) )
230 allocate( lcmesh%Sz(refelem%Np,lcmesh%Ne) )
231 allocate( lcmesh%Gsqrt(refelem%Np,lcmesh%NeA) )
232 allocate( lcmesh%GsqrtH(refelem%Nfp_v,lcmesh%Ne2D) )
233 allocate( lcmesh%G_ij(refelem%Nfp_v,lcmesh%Ne2D,2,2) )
234 allocate( lcmesh%GIJ (refelem%Nfp_v,lcmesh%Ne2D,2,2) )
235 allocate( lcmesh%GI3 (refelem%Np,lcmesh%NeA,2) )
236 allocate( lcmesh%zlev(refelem%Np,lcmesh%Ne) )
237 allocate( lcmesh%gam(refelem%Np,lcmesh%NeA) )
238
239 allocate( lcmesh%lon2D(refelem%Nfp_v,lcmesh%Ne2D) )
240 allocate( lcmesh%lat2D(refelem%Nfp_v,lcmesh%Ne2D) )
241
242 do f=1, refelem%Nfaces_h
243 do i=1, refelem%Nfp_h
244 fid_h(i,f) = i + (f-1)*refelem%Nfp_h
245 fmask(fid_h(i,f)) = refelem%Fmask_h(i,f)
246 end do
247 end do
248 do f=1, refelem%Nfaces_v
249 do i=1, refelem%Nfp_v
250 fid_v(i,f) = i + refelem%Nfaces_h*refelem%Nfp_h + (f-1)*refelem%Nfp_v
251 fmask(fid_v(i,f)) = refelem%Fmask_v(i,f)
252 end do
253 end do
254
255 !$omp parallel private( ke, node_ids, vx, vy, vz, &
256 !$omp xX, xY, xZ, yX, yY, yZ, zX, zY, zZ, &
257 !$omp i, j, Escale_f, d )
258
259 !$omp do
260 do ke=1, lcmesh%Ne
261 node_ids(:) = lcmesh%EToV(ke,:)
262 vx(:) = lcmesh%pos_ev(node_ids(:),1)
263 vy(:) = lcmesh%pos_ev(node_ids(:),2)
264 vz(:) = lcmesh%pos_ev(node_ids(:),3)
265 call coord_conv( &
266 lcmesh%pos_en(:,ke,1), lcmesh%pos_en(:,ke,2), lcmesh%pos_en(:,ke,3), & ! (out)
267 xx, xy, xz, yx, yy, yz, zx, zy, zz, & ! (out)
268 vx, vy, vz, refelem ) ! (in)
269
270 lcmesh%J(:,ke) = xx(:)*(yy(:)*zz(:) - zy(:)*yz) &
271 - yx(:)*(xy(:)*zz(:) - zy(:)*xz) &
272 + zx(:)*(xy(:)*yz(:) - yy(:)*xz)
273
274 lcmesh%Escale(:,ke,1,1) = (yy(:)*zz(:) - zy(:)*yz(:))/lcmesh%J(:,ke)
275 lcmesh%Escale(:,ke,1,2) = - (xy(:)*zz(:) - zy(:)*xz(:))/lcmesh%J(:,ke)
276 lcmesh%Escale(:,ke,1,3) = (xy(:)*yz(:) - yy(:)*xz(:))/lcmesh%J(:,ke)
277
278 lcmesh%Escale(:,ke,2,1) = - (yx(:)*zz(:) - zx(:)*yz(:))/lcmesh%J(:,ke)
279 lcmesh%Escale(:,ke,2,2) = (xx(:)*zz(:) - zx(:)*xz(:))/lcmesh%J(:,ke)
280 lcmesh%Escale(:,ke,2,3) = - (xx(:)*yz(:) - yx(:)*xz(:))/lcmesh%J(:,ke)
281
282 lcmesh%Escale(:,ke,3,1) = (yx(:)*zy(:) - zx(:)*yy(:))/lcmesh%J(:,ke)
283 lcmesh%Escale(:,ke,3,2) = - (xx(:)*zy(:) - zx(:)*xy(:))/lcmesh%J(:,ke)
284 lcmesh%Escale(:,ke,3,3) = (xx(:)*yy(:) - yx(:)*xy(:))/lcmesh%J(:,ke)
285
286 !* Face
287
288 !
289 !mesh%fx(:,n) = mesh%x(fmask(:),n)
290 !mesh%fy(:,n) = mesh%y(fmask(:),n)
291
292 ! Calculate normal vectors
293 do j=1, 3
294 do i=1, 3
295 escale_f(:,i,j) = lcmesh%Escale(fmask(:),ke,i,j)
296 end do
297 end do
298 call calc_normal( lcmesh%normal_fn(:,ke,:), & ! (out)
299 escale_f, fid_h, fid_v, refelem ) ! (in)
300
301 lcmesh%sJ(:,ke) = sqrt( &
302 lcmesh%normal_fn(:,ke,1)**2 + lcmesh%normal_fn(:,ke,2)**2 + lcmesh%normal_fn(:,ke,3)**2 )
303 do d=1, 3
304 lcmesh%normal_fn(:,ke,d) = lcmesh%normal_fn(:,ke,d)/lcmesh%sJ(:,ke)
305 end do
306 lcmesh%sJ(:,ke) = lcmesh%sJ(:,ke)*lcmesh%J(fmask(:),ke)
307
308 lcmesh%Fscale(:,ke) = lcmesh%sJ(:,ke)/lcmesh%J(fmask(:),ke)
309 lcmesh%zlev(:,ke) = lcmesh%pos_en(:,ke,3)
310 end do
311 !$omp end do
312
313 !$omp workshare
314 lcmesh%Gsqrt (:,:) = 1.0_rp
315 lcmesh%GsqrtH(:,:) = 1.0_rp
316 lcmesh%GIJ (:,:,1,1) = 1.0_rp
317 lcmesh%GIJ (:,:,2,1) = 0.0_rp
318 lcmesh%GIJ (:,:,1,2) = 0.0_rp
319 lcmesh%GIJ (:,:,2,2) = 1.0_rp
320 lcmesh%G_ij (:,:,1,1) = 1.0_rp
321 lcmesh%G_ij (:,:,2,1) = 0.0_rp
322 lcmesh%G_ij (:,:,1,2) = 0.0_rp
323 lcmesh%G_ij (:,:,2,2) = 1.0_rp
324 lcmesh%GI3 (:,:,1) = 0.0_rp
325 lcmesh%GI3 (:,:,2) = 0.0_rp
326 lcmesh%gam (:,:) = 1.0_rp
327 !$omp end workshare
328
329 !$omp end parallel
330
331 return

Referenced by scale_mesh_base3d::meshbase3d_generate::meshbase3d_generate(), scale_mesh_cubedom3d::meshcubedom3d_init(), and scale_mesh_cubedspheredom3d::meshcubedspheredom3d_init().

Variable Documentation

◆ meshbase3d_dimtype_num

integer, public scale_mesh_base3d::meshbase3d_dimtype_num = 8

Definition at line 78 of file scale_mesh_base3d.F90.

78 integer, public :: MESHBASE3D_DIMTYPE_NUM = 8

Referenced by scale_file_history_meshfield::file_history_meshfield_in::file_history_meshfield_in3d(), and meshbase3d_init().

◆ meshbase3d_dimtypeid_x

integer, public scale_mesh_base3d::meshbase3d_dimtypeid_x = 1

◆ meshbase3d_dimtypeid_y

integer, public scale_mesh_base3d::meshbase3d_dimtypeid_y = 2

◆ meshbase3d_dimtypeid_z

integer, public scale_mesh_base3d::meshbase3d_dimtypeid_z = 3

◆ meshbase3d_dimtypeid_zt

integer, public scale_mesh_base3d::meshbase3d_dimtypeid_zt = 4

◆ meshbase3d_dimtypeid_xy

integer, public scale_mesh_base3d::meshbase3d_dimtypeid_xy = 5

◆ meshbase3d_dimtypeid_xyt

integer, public scale_mesh_base3d::meshbase3d_dimtypeid_xyt = 6

◆ meshbase3d_dimtypeid_xyz

integer, public scale_mesh_base3d::meshbase3d_dimtypeid_xyz = 7

◆ meshbase3d_dimtypeid_xyzt

integer, public scale_mesh_base3d::meshbase3d_dimtypeid_xyzt = 8