FE-Project
Loading...
Searching...
No Matches
Functions/Subroutines
scale_meshutil_1d Module Reference

module FElib / Mesh / utility for 1D mesh More...

Functions/Subroutines

subroutine, public meshutil1d_genlinedomain (pos_v, etov, ke_x, xmin, xmax, fx)
 
subroutine, public meshutil1d_genconnectivity (etoe, etof, etov, ne, nfaces)
 
subroutine, public meshutil1d_buildinteriormap (vmapm, vmapp, mapm, mapp, pos_en, pos_ev, etoe, etof, etov, fmask, ne, np, nfp, nfaces, nv)
 
subroutine, public meshutil1d_genpatchboundarymap (vmapb, mapb, vmapp, pos_en, xmin, xmax, fmask, ne, np, nfp, nfaces, nv)
 
subroutine, public meshutil1d_genperiodicboundarymap (etoe, etof, vmapp, xperiod, x, fx, fmask, ne, np, nfp, nfaces, nv)
 
subroutine, public meshutil1d_buildglobalmap (panelid_table, pi_table, tileid_map, tilefaceid_map, tilepanelid_map, ntile)
 

Detailed Description

module FElib / Mesh / utility for 1D mesh

Description
A module useful for generating 1D mesh
Author
Yuta Kawai, Team SCALE

Function/Subroutine Documentation

◆ meshutil1d_genlinedomain()

subroutine, public scale_meshutil_1d::meshutil1d_genlinedomain ( real(rp), dimension(ke_x+1,1), intent(out) pos_v,
integer, dimension(ke_x,2), intent(out) etov,
integer, intent(in) ke_x,
real(rp), intent(in) xmin,
real(rp), intent(in) xmax,
real(rp), dimension(ke_x+1), intent(in), optional fx )

Definition at line 35 of file scale_meshutil_1d.F90.

38
39 implicit none
40
41 integer, intent(in) :: Ke_x
42 real(RP), intent(in) :: xmin, xmax
43 real(RP), intent(in), optional :: Fx(Ke_x+1)
44
45 real(RP), intent(out) :: pos_v(Ke_x+1,1)
46 integer, intent(out) :: EToV(Ke_x,2)
47
48 integer :: i
49 integer :: n
50 integer :: NvX
51
52 !-----------------------------------------------------------------------------
53
54 nvx = ke_x + 1
55
56 do i=1, nvx
57 if (present(fx) ) then
58 pos_v(i,1) = fx(i)
59 else
60 pos_v(i,1) = (xmax - xmin)*dble(i - 1)/dble(nvx - 1) + xmin
61 end if
62 end do
63
64 do i=1, ke_x
65 etov(i,1:2) = (/ i, i+1 /)
66 end do
67
68 !---
69 !!$
70 !!$ write(*,*) "-- vx, vy --"
71 !!$ do j=1, NvY
72 !!$ do i=1, NvX
73 !!$ n = i + (j-1)*NvY
74 !!$ write(*,*) i, j, " :", mesh%vx(n), mesh%vy(n)
75 !!$ end do
76 !!$ end do
77 !!$
78 !!$ write(*,*) "-- EToV --"
79 !!$ do j=1, Ke_y
80 !!$ do i=1, Ke_x
81 !!$ n = i + (j-1)*Ke_y
82 !!$ write(*,*) i, j, " :", mesh%EToV(n,:)
83 !!$ end do
84 !!$ end do
85
86 return

Referenced by scale_mesh_base1d::meshbase1d_setuplocaldom().

◆ meshutil1d_genconnectivity()

subroutine, public scale_meshutil_1d::meshutil1d_genconnectivity ( integer, dimension(ne, nfaces), intent(out) etoe,
integer, dimension(ne, nfaces), intent(out) etof,
integer, dimension(ne,2), intent(in) etov,
integer, intent(in) ne,
integer, intent(in) nfaces )

Definition at line 90 of file scale_meshutil_1d.F90.

92
93 implicit none
94
95 integer, intent(in) :: Ne
96 integer, intent(in) :: Nfaces
97 integer, intent(out) :: EToE(Ne, Nfaces)
98 integer, intent(out) :: EToF(Ne, Nfaces)
99 integer, intent(in) :: EToV(Ne,2)
100
101 integer :: nodes(Ne*Nfaces,1)
102 integer :: face_ids(Ne*Nfaces)
103 integer :: spNodeToNode(Ne*Nfaces,4)
104 integer :: k
105 integer :: f
106 integer :: n
107 integer :: n1, n2
108 integer :: Nnodes
109 integer :: tmp
110 integer :: spNodeToNodeRowTmp(4)
111 integer :: Nnodes_row
112 integer :: matchL(2,4), matchR(2,4)
113
114 real(RP) :: EToE_1d(Ne*Nfaces)
115 real(RP) :: EToF_1d(Ne*Nfaces)
116 !-----------------------------------------------------------------------------
117
118 nnodes = maxval( etov )
119 nnodes_row = size(nodes,1)
120
121 !---------
122 do n=1, ne
123 nodes(n ,:) = etov(n,(/ 1 /))
124 nodes(n+ne ,:) = etov(n,(/ 2 /))
125 end do
126 nodes = nodes - 1
127
128 !---------
129
130 do n=1, ne
131 etoe(n,:) = n
132 etof(n,:) = (/ 1, 2 /)
133 end do
134
135 face_ids(:) = nodes(:,1) + 1
136
137 do f=1, nfaces
138 do k=1, ne
139 n = k + (f-1)*ne
140 spnodetonode(n,:) = (/ face_ids(n), n, etoe(k,f), etof(k,f) /)
141 ! write(*,*) "face_id, n, EToE, EToF:", spNodeToNode(n,:)
142 end do
143 end do
144
145 ! Sort row
146 do n1=1, nnodes_row-1
147 do n2=n1+1, nnodes_row
148 if (spnodetonode(n1,1) > spnodetonode(n2,1)) then
149 spnodetonoderowtmp(:) = spnodetonode(n1,:)
150 spnodetonode(n1,:) = spnodetonode(n2,:)
151 spnodetonode(n2,:) = spnodetonoderowtmp
152 end if
153 end do
154 end do
155
156 ! do n=1, Nnodes_row
157 ! write(*,*) "(sorted) face_id, n, EToE, EToF:", spNodeToNode(n,:)
158 ! end do
159
160 !
161 etoe_1d(:) = -1
162 etof_1d(:) = -1
163 do n=1, nnodes_row-1
164 if ( spnodetonode(n,1) - spnodetonode(n+1,1) == 0 ) then
165 matchl(:,:) = spnodetonode((/ n, n+1 /), :)
166 matchr(:,:) = spnodetonode((/ n+1, n /), :)
167
168 etoe_1d(matchl(:,2)) = matchr(:,3)
169 etof_1d(matchl(:,2)) = matchr(:,4)
170 end if
171 end do
172
173 do f=1, nfaces
174 do k=1, ne
175 n = k + (f-1)*ne
176 if ( etoe_1d(n) /= -1 ) then
177 etoe(k,f) = etoe_1d(n)
178 etof(k,f) = etof_1d(n)
179 end if
180 end do
181 end do
182
183 !-------------------
184
185! write(*,*) "EToE------"
186! do k=1, mesh%Ne
187! write(*,*) "k=", k, ":", mesh%EToE(k,:)
188! end do
189! write(*,*) "EToF------"
190! do k=1, mesh%Ne
191! write(*,*) "k=", k, ":", mesh%EToF(k,:)
192! end do
193
194 return

Referenced by scale_mesh_base1d::meshbase1d_setuplocaldom(), and meshutil1d_buildglobalmap().

◆ meshutil1d_buildinteriormap()

subroutine, public scale_meshutil_1d::meshutil1d_buildinteriormap ( integer, dimension(nfp,nfaces,ne), intent(out) vmapm,
integer, dimension(nfp,nfaces,ne), intent(out) vmapp,
integer, dimension(nfp,nfaces,ne), intent(out) mapm,
integer, dimension(nfp,nfaces,ne), intent(out) mapp,
real(rp), dimension(np,ne,1), intent(in) pos_en,
real(rp), dimension(nv,1), intent(in) pos_ev,
integer, dimension(ne, nfaces), intent(in) etoe,
integer, dimension(ne, nfaces), intent(in) etof,
integer, dimension(ne,2), intent(in) etov,
integer, dimension(nfp,2), intent(in) fmask,
integer, intent(in) ne,
integer, intent(in) np,
integer, intent(in) nfp,
integer, intent(in) nfaces,
integer, intent(in) nv )

Definition at line 198 of file scale_meshutil_1d.F90.

200
201
202 implicit none
203
204 integer, intent(in) :: Ne
205 integer, intent(in) :: Np
206 integer, intent(in) :: Nfp
207 integer, intent(in) :: Nfaces
208 integer, intent(in) :: Nv
209
210 integer, intent(out) :: VMapM(Nfp,Nfaces,Ne)
211 integer, intent(out) :: VMapP(Nfp,Nfaces,Ne)
212 integer, intent(out) :: MapM(Nfp,Nfaces,Ne)
213 integer, intent(out) :: MapP(Nfp,Nfaces,Ne)
214
215 real(RP), intent(in) :: pos_en(Np,Ne,1)
216 real(RP), intent(in) :: pos_ev(Nv,1)
217 integer, intent(in) :: EToE(Ne, Nfaces)
218 integer, intent(in) :: EToF(Ne, Nfaces)
219 integer, intent(in) :: EToV(Ne,2)
220 integer, intent(in) :: Fmask(Nfp,2)
221
222
223 integer :: k, k1, k2
224 integer :: f, f1, f2
225 integer :: p
226 integer :: n
227 integer :: idP, idM
228 integer :: v1, v2
229 integer :: nodeids(Np,Ne)
230 real(RP) :: refd2
231 real(RP) :: x1(Nfp,Nfp), x2(Nfp,Nfp)
232 real(RP) :: dist(Nfp,Nfp)
233 real(RP) :: x(Np*Ne)
234 !-----------------------------------------------------------------------------
235
236 do k=1, ne
237 do p=1, np
238 n = p + (k-1)*np
239 nodeids(p,k) = n
240 x(n) = pos_en(p,k,1)
241 end do
242 end do
243
244 do k=1, ne
245 do f=1, nfaces
246 do p=1, nfp
247 n = p + (f-1)*nfp + (k-1)*nfp*nfaces
248 mapm(p,f,k) = n
249 mapp(p,f,k) = n
250 vmapm(p,f,k) = nodeids(fmask(p,f),k)
251 end do
252 end do
253 end do
254
255 vmapp(:,:,:) = -1
256 do k1=1, ne
257 do f1=1, nfaces
258 k2 = etoe(k1,f1); f2 = etof(k1,f1)
259
260 v1 = etov(k1,f1); v2 = etov(k1,1+mod(f1,nfaces))
261 refd2 = (pos_ev(v1,1) - pos_ev(v2,1))**2
262
263 x1(:,:) = spread( x(vmapm(:,f1,k1)), 2, nfp )
264 x2(:,:) = spread( x(vmapm(:,f2,k2)), 1, nfp )
265
266 dist(:,:) = (x1 - x2)**2
267 do idp=1, nfp
268 do idm=1, nfp
269 if (dist(idm,idp)/refd2 < 1.0e-14_rp) then
270 vmapp(idm,f1,k1) = vmapm(idp,f2,k2)
271 mapp(idm,f1,k1) = idp + (f2-1)*nfp + (k2-1)*nfp*nfaces
272 end if
273 end do
274 end do
275 end do
276 end do
277
278 !-----
279! mapB_counter = 0
280! do k=1,mesh%Ne
281! do f=1,elem%Nfaces
282! do p=1,elem%Nfp
283! n = p + (f-1)*elem%Nfp + (k-1)*elem%Nfp*elem%Nfaces
284! if (mesh%VMapM(p,f,k) == mesh%VMapP(p,f,k)) then
285! mapB_counter = mapB_counter + 1
286! mapB_tmp(mapB_counter) = n
287!
288! vmapB_tmp(mapB_counter) = mesh%VMapM(p,f,k)
289! mesh%VMapP(p,f,k) = elem%Np*mesh%NeE + mapB_counter
290! end if
291! end do
292! end do
293! end do
294!
295! allocate( mesh%mapB(mapB_counter) )
296! allocate( mesh%vmapB(mapB_counter) )
297! mesh%mapB(:) = mapB_tmp(1:mapB_counter)
298! mesh%vmapB(:) = vmapB_tmp(1:mapB_counter)
299
300 !-------
301 ! write(*,*) "Build MapInfo: "
302 ! do k=1,Ne
303 ! write(*,*) "k=", k, "---"
304 ! write(*,*) " VMapM:", VMapM(:,:,k)
305 ! write(*,*) " VMapP:", VMapP(:,:,k)
306 ! end do
307
308! write(*,*) "mapB:", mesh%mapB(:)
309! write(*,*) "vmapB:", mesh%vmapB(:)
310
311 return

Referenced by scale_mesh_base1d::meshbase1d_setuplocaldom().

◆ meshutil1d_genpatchboundarymap()

subroutine, public scale_meshutil_1d::meshutil1d_genpatchboundarymap ( integer, dimension(:), intent(inout), allocatable vmapb,
integer, dimension(:), intent(inout), allocatable mapb,
integer, dimension(nfp,nfaces,ne), intent(inout) vmapp,
real(rp), dimension(np,ne,1), intent(in) pos_en,
real(rp), intent(in) xmin,
real(rp), intent(in) xmax,
integer, dimension(nfp,2), intent(in) fmask,
integer, intent(in) ne,
integer, intent(in) np,
integer, intent(in) nfp,
integer, intent(in) nfaces,
integer, intent(in) nv )

Definition at line 315 of file scale_meshutil_1d.F90.

317
318 implicit none
319
320 integer, intent(in) :: Ne
321 integer, intent(in) :: Np
322 integer, intent(in) :: Nfp
323 integer, intent(in) :: Nfaces
324 integer, intent(in) :: Nv
325
326 integer, intent(inout), allocatable :: VMapB(:)
327 integer, intent(inout), allocatable :: MapB(:)
328 integer, intent(inout) :: VMapP(Nfp,Nfaces,Ne)
329
330 real(RP), intent(in) :: pos_en(Np,Ne,1)
331 real(RP), intent(in) :: xmin, xmax
332 integer, intent(in) :: Fmask(Nfp,2)
333
334 integer :: k
335 integer :: b
336 integer :: f
337 integer :: i, j
338 real(RP) :: x
339
340 real(RP), parameter :: NODE_TOL = 1.0e-12_rp
341
342 integer :: elemIDs(Nfp*Ne,2)
343 integer :: faceIDs(Nfp*Ne,2)
344 integer :: counterB(2)
345 integer :: mapB_counter
346 real(RP) :: rdomx
347 !-----------------------------------------------------------------------------
348
349 counterb(:) = 0d0
350 rdomx = 1.0_rp/(xmax - xmin)
351
352 do k=1, ne
353 do f=1, nfaces
354 x = sum(pos_en(fmask(:,f),k,1)/dble(nfp))
355
356 call eval_domain_boundary(1, x, xmin, k, f, rdomx)
357 call eval_domain_boundary(2, x, xmax, k, f, rdomx)
358 end do
359 end do
360
361
362 allocate( mapb(sum(counterb*nfp)) )
363 allocate( vmapb(size(mapb)) )
364
365 mapb_counter = 1
366 do b = 1, 2
367 ! write(*,*) "LocalMesh boundary ID:", b
368 ! write(*,*) counterB(b)
369 ! write(*,*) ordInfo(1:counterB(1),b)
370 ! write(*,*) elemIds(1:counterB(1),b)
371 ! write(*,*) faceIds(1:counterB(1),b)
372
373 do i=1, counterb(b)
374 k = elemids(i,b); f = faceids(i,b)
375 do j=1, nfp
376 vmapp(j,f,k) = np*ne + mapb_counter
377 vmapb(mapb_counter) = fmask(j,f) + (k-1)*np
378 mapb_counter = mapb_counter + 1
379 end do
380 end do
381 end do
382
383 ! write(*,*) "VMapP:-----"
384 ! do b=1, 4
385 ! do i=1, counterB(b)
386 ! k = elemIds(i,b); f = faceIDs(i,b)
387 ! write(*,*) "bid=", b, ":", mesh%VmapP(:,f,k)
388 ! end do
389 ! end do
390 ! write(*,*) "-----"
391 ! write(*,*) "VMapB:", mesh%VmapB(:)
392 ! write(*,*) "NeA=", mesh%NeA
393
394 return
395 contains
396 subroutine eval_domain_boundary(domb_id, r, rbc, k_, f_, normalized_fac)
397 implicit none
398 integer, intent(in) :: domb_id
399 real(RP), intent(in) :: r
400 real(RP), intent(in) :: rbc
401 integer, intent(in) :: k_, f_
402 real(RP), intent(in) :: normalized_fac
403 !-------------------------------------------------------------
404
405 if ( abs(r - rbc)*normalized_fac < node_tol ) then
406 counterb(domb_id) = counterb(domb_id) + 1
407 elemids(counterb(domb_id),domb_id) = k_
408 faceids(counterb(domb_id),domb_id) = f_
409 end if
410
411 return
412 end subroutine eval_domain_boundary

Referenced by scale_mesh_base1d::meshbase1d_setuplocaldom().

◆ meshutil1d_genperiodicboundarymap()

subroutine, public scale_meshutil_1d::meshutil1d_genperiodicboundarymap ( integer, dimension(ne, nfaces), intent(inout) etoe,
integer, dimension(ne, nfaces), intent(inout) etof,
integer, dimension(nfp,nfaces,ne), intent(inout) vmapp,
real(rp), intent(in) xperiod,
real(rp), dimension(np,ne), intent(in) x,
real(rp), dimension(nfp*ne), intent(in) fx,
integer, dimension(nfp,4), intent(in) fmask,
integer, intent(in) ne,
integer, intent(in) np,
integer, intent(in) nfp,
integer, intent(in) nfaces,
integer, intent(in) nv )

Definition at line 416 of file scale_meshutil_1d.F90.

418
419 implicit none
420
421 integer, intent(in) :: Ne
422 integer, intent(in) :: Np
423 integer, intent(in) :: Nfp
424 integer, intent(in) :: Nfaces
425 integer, intent(in) :: Nv
426 integer, intent(inout) :: EToE(Ne, Nfaces)
427 integer, intent(inout) :: EToF(Ne, Nfaces)
428 integer, intent(inout) :: VMapP(Nfp,Nfaces,Ne)
429 real(RP), intent(in) :: xperiod
430 real(RP), intent(in) :: x(Np,Ne)
431 real(RP), intent(in) :: fx(Nfp*Ne)
432 integer, intent(in) :: Fmask(Nfp,4)
433
434 integer :: k, k1, k2
435 integer :: f, f1, f2
436 integer :: p
437 integer :: n
438
439 real(RP) :: cx1, cx2
440 real(RP) :: dx_pbc
441 integer :: idP, idM
442 integer :: vidL(Nfp), vidR(Nfp)
443 integer :: fidL(Nfp), fidR(Nfp)
444
445 real(RP) :: refd2
446 real(RP) :: x1(Nfp,Nfp), x2(Nfp,Nfp)
447 real(RP) :: dist(Nfp,Nfp)
448
449 real(RP), parameter :: NODE_TOL = 1.0e-12_rp
450 !-----------------------------------------------------------------------------
451
452
453 do k1=1, ne
454 do f1=1, nfaces
455 cx1 = sum(x(fmask(:,f1),k1)/dble(nfp))
456
457 k2 = etoe(k1,f1); f2 = etof(k1,f1)
458 if (k2==k1) then
459 do k2=1, ne
460 if (k1 /= k2) then
461 do f2=1, nfaces
462 if (etoe(k2,f2) == k2) then
463 cx2 = sum(x(fmask(:,f2),k2)/dble(nfp))
464
465 dx_pbc = sqrt( (abs(cx1-cx2)-xperiod)**2 )
466
467 if (dx_pbc < node_tol) then
468
469 etoe(k1,f1) = k2; etoe(k2,f2) = k1
470 etof(k1,f1) = f2; etof(k2,f2) = f1
471
472 !mesh%BCType(f1,k1) = BCTYPE_PERIODIC
473 !mesh%BCType(f2,k2) = BCTYPE_PERIODIC
474
475 do p=1, nfp
476 vidl(p) = fmask(p,f1) + (k1-1)*np
477 vidr(p) = fmask(p,f2) + (k2-1)*np
478 fidl(p) = p + (f1-1)*nfp + (k1-1)*nfp*nfaces
479 fidr(p) = p + (f2-1)*nfp + (k2-1)*nfp*nfaces
480 end do
481
482 x1(:,:) = spread( fx(fidl(:)), 2, nfp )
483 x2(:,:) = spread( fx(fidr(:)), 1, nfp )
484
485 dist(:,:) = (abs(x1-x2) -xperiod)**2
486
487 do idp=1,nfp
488 do idm=1,nfp
489 if (dist(idm,idp) < node_tol) then
490 vmapp(idm,f1,k1) = vidr(idp)
491 vmapp(idp,f2,k2) = vidl(idm)
492 end if
493 end do
494 end do
495
496 end if
497 end if
498 end do
499 end if
500 end do
501 end if
502
503 end do
504 end do
505
506 !-------
507
508! write(*,*) "Build MapInfo (Periodic BC): "
509! do k=1,mesh%Ne
510! write(*,*) "k=", k, "---"
511! write(*,*) " VMapM:", mesh%VMapM(:,:,k)
512! write(*,*) " VMapP:", mesh%VMapP(:,:,k)
513! write(*,*) "BCType:", mesh%BCType(:,k)
514! end do
515
516 return

◆ meshutil1d_buildglobalmap()

subroutine, public scale_meshutil_1d::meshutil1d_buildglobalmap ( integer, dimension(ntile), intent(out) panelid_table,
integer, dimension(ntile), intent(out) pi_table,
integer, dimension(2,ntile), intent(out) tileid_map,
integer, dimension(2,ntile), intent(out) tilefaceid_map,
integer, dimension(2,ntile), intent(out) tilepanelid_map,
integer, intent(in) ntile )

Definition at line 520 of file scale_meshutil_1d.F90.

524
525 use scale_prc, only: prc_ismaster
526 implicit none
527
528 integer, intent(in) :: Ntile
529 integer, intent(out) :: panelID_table(Ntile)
530 integer, intent(out) :: pi_table(Ntile)
531 integer, intent(out) :: tileID_map(2,Ntile)
532 integer, intent(out) :: tileFaceID_map(2,Ntile)
533 integer, intent(out) :: tilePanelID_map(2,Ntile)
534
535 integer :: NtilePerPanel
536 integer :: Ne, Nv
537 integer, allocatable :: nodesID_1d(:)
538 integer, allocatable :: EToV(:,:)
539 integer, allocatable :: EToE(:,:)
540 integer, allocatable :: EToF(:,:)
541 integer :: i, f
542 integer :: panelID
543 integer :: tileID, tileID_R
544 integer :: counter
545 real(DP) :: del
546
547 !-----------------------------------------------------------------------------
548
549 ntileperpanel = ntile
550 ne = ntileperpanel
551 nv = ne + 1
552 allocate( nodesid_1d(nv) )
553 allocate( etov(ntile,2), etoe(ntile,2), etof(ntile,2) )
554
555 nodesid_1d(:) = -1
556 counter = 0
557 do i = 2, nv-1
558 counter = counter + 1
559 nodesid_1d(i) = counter
560 end do
561
562 !----
563
564 tileid = 0
565
566 do i = 1, ne
567 tileid = tileid + 1
568 panelid_table(tileid) = 1
569 pi_table(tileid) = i
570 etov(tileid,:) = (/ nodesid_1d(i), nodesid_1d(i+1) /)
571 end do
572
573 call meshutil1d_genconnectivity( etoe, etof, &
574 & etov, ntile, 2 )
575 tileid_map(:,:) = transpose(etoe)
576 tilefaceid_map(:,:) = transpose(etof)
577
578 do tileid=1, ntile
579 do f=1, 2
580 tileid_r = tileid_map(f,tileid)
581 tilepanelid_map(f,tileid) = panelid_table(tileid_r)
582 end do
583 end do
584
585 !--
586
587 ! if (PRC_isMaster) then
588 !
589 ! write(*,*) "TotTile", tileID, Ntile
590 ! do tileID = 1, Ntile
591 ! write(*,*) "tileID:", tileID, ", EtoV:", EtoV(tileID,:)
592 ! end do
593 ! write(*,*) "-----------"
594 ! do tileID = 1, Ntile
595 ! write(*,*) "tileID:", tileID, ", EtoE:", EtoE(tileID,:)
596 ! end do
597 ! write(*,*) "-----------"
598 ! do tileID = 1, Ntile
599 ! write(*,*) "tileID:", tileID, ", EtoF:", EtoF(tileID,:)
600 ! end do
601 !
602 ! end if
603
604 return

References meshutil1d_genconnectivity().

Referenced by scale_mesh_base1d::meshbase1d_assigndomid().