Next Article in Journal
Current and Prospective Radiation Detection Systems, Screening Infrastructure and Interpretive Algorithms for the Non-Intrusive Screening of Shipping Container Cargo: A Review
Next Article in Special Issue
Coupled Thermal-Hydraulic Analysis and Species Mass Transport in a Versatile Experimental Salt Irradiation Loop (VESIL) Using CTF
Previous Article in Journal
Effect of Pre-Heating and Post-Heating on Electron Beam Welding of Reduced Activation Ferrite/Martensite Steel
Previous Article in Special Issue
Self-Consistent Energy Normalization for Quasistatic Reactor Calculations
 
 
Font Type:
Arial Georgia Verdana
Font Size:
Aa Aa Aa
Line Spacing:
Column Width:
Background:
Article

Arbitrary-Order Bernstein–Bézier Functions for DGFEM Transport on 3D Polygonal Grids

Naval Nuclear Laboratory, P.O. Box 1072, Schenectady, NY 12301, USA
J. Nucl. Eng. 2021, 2(3), 239-245; https://0-doi-org.brum.beds.ac.uk/10.3390/jne2030022
Submission received: 29 September 2020 / Revised: 27 July 2021 / Accepted: 29 July 2021 / Published: 31 July 2021
(This article belongs to the Special Issue Selected Papers from PHYSOR 2020)

Abstract

:
In this paper, we present an arbitrary-order discontinuous Galerkin finite element discretization of the S N transport equation on 3D extruded polygonal prisms. Basis functions are formed by the tensor product of 2D polygonal Bernstein–Bézier functions and 1D Lagrange polynomials. For a polynomial degree p, these functions span { x a y b } ( a + b ) p { z c } c ( 0 , p ) with a dimension of n p ( p + 1 ) + ( p + 1 ) ( p 1 ) ( p 2 ) / 2 on an extruded n-gon. Numerical tests confirm that the functions capture exactly monomial solutions, achieve expected convergence rates, and provide full resolution in the thick diffusion limit.

1. Introduction

The linear Boltzmann transport equation, which we will simply call the transport equation, describes the transport of neutral particles (i.e., neutrons and photons) through background and multiplying media [1]. Some of the most prevalent discretization schemes are the discrete ordinates ( S N ) in angle and multigroup in energy. Given an angular quadrature set, { w m , Ω m } m = 1 M , the multigroup, S N transport equation for the angular flux of group g traveling in direction Ω m , denoted as ψ m , g ( r ) ψ g ( r , Ω m ) , with isotropic scattering within an open, convex spatial domain D , with boundary, D , is written as
Ω m · ψ m , g ( r ) + σ t , g ( r ) ψ m , g ( r ) = 1 4 π g = 1 G σ s g g ( r ) ϕ g ( r ) + q m , g ( r ) ,
where the source term is given by
q m , g ( r ) = 1 4 π S g ( r ) , Fixed - Source χ g 4 π k g = 1 G ν σ f , g ( r ) ϕ g ( r ) . Eigenvalue
σ t , g is the total cross section of group g, σ s g g is the scattering cross section from group g to group g, ν σ f , g is the fission neutron production term of group g, χ g is the neutron fission spectrum of group g, S g is a distributed source, and the scalar flux of group g, is given by
ϕ g ( r ) 4 π d Ω ψ g ( r , Ω ) m = 1 M w m ψ m , g ( r ) .
The discontinuous Galerkin finite element method (DGFEM) is a popular spatial discretization for Equation (1) [2,3,4]. Besides 1D, the use of DGFEM for transport has typically been reserved for meshes employing simplicial or tensor mesh cells. Stone and Adams [5] developed a discretization with linear precision for unstructured polygonal cells, which Bailey [6] later extended to unstructured polyhedral cells. Hackemack and Ragusa [7] analyzed quadratic serendipity functions on polygonal grids, which was further extended to extruded polygonal prisms [8]. Recently, utilizing the framework of Floater and Lai [9], Hackemack [10,11] analyzed arbitrary-order DGFEM S N and diffusion solutions on 2D polygonal grids using reduced-space polygonal Bernstein–Bézier functions. This work extends [10] to form arbitrary-order tensor-based functions on extruded polygonal prisms.
The remainder of this paper is as follows. In Section 2, we present the DGFEM discretization of the S N transport equation, followed by the employed 3D extruded basis functions in Section 3. Then, Section 4 presents numerical results demonstrating the expected precision and convergence properties of our DGFEM discretization. Finally, conclusions are presented in Section 5.

2. The DGFEM Transport Equation

In this section, we review the DGFEM discretization of the S N transport equation. First, we lay down an unstructured mesh, T h R 3 , over the spatial domain consisting of non-overlapping spatial elements to form a complete union over the spatial domain: D = K T h K . The angular flux unknown of Equation (1) is expanded using discontinuous functions over each mesh cell K:
ψ m , g ( r ) j = 1 N K ψ m , g , j u m , g , j ( r ) , r K ,
where N K is the number of basis functions on element K, and the functions are nonzero over a single element and discontinuous across the element interfaces. The scalar flux and source term can be expanded analogously. Multiplying Equation (1) by a test function u, integrating over element K, applying the divergence theorem, and using the standard upwind technique yields the following weak form over element K:
( Ω m · n ) u , ψ m , g K + Ω m · u , ψ m , g K + σ t , g u , ψ m , g K = 1 4 π g = 1 G σ s g g u , ϕ g K + u , q m , g K ( Ω m · n ) u , ψ m , g K .
In Equation (5), K ± represents the outflow/inflow boundary, K ± = r K | Ω m · n K ( r ) 0 ; with n K ( r ) the outward unit normal, ψ m are the angular flux values on an inflow face taken from the upwind neighbor element, and the inner products
v , w K K v w d r and v , w K K v w d s
correspond to integrations over the cell volume and faces, respectively, where d r R 3 is within the cell and d s R 2 is along the cell boundary.
The error of the discretized flux solution ϕ h p W D h p with polynomial degree p, under the L 2 -norm, can be written as
| | ϕ ϕ h p | | L 2 C h min ( p + 1 , r ) ( p + 1 ) r ,
where h is the maximum diameter of all mesh elements, r is the regularity of the transport solution, and C is a constant independent of the mesh. Therefore, the convergence rates are limited by the solution regularity [3].

3. 3D Extruded Polygonal Basis Functions

In Section 2, we gave the DGFEM discretization of the S N transport equation but no definition to the test and trial functions. Now, we provide some details on the employed polygonal prism basis functions. Our extruded polygonal functions are formed from the tensor product of the 2D polygonal Bernstein–Bézier functions (we will refer to them as the ( x , y ) radial functions) and the 1D Lagrange polynomials (we will refer to them as the z axial functions).

3.1. Brief Overview of 2D Polygonal Functions

We now provide a brief overview of the radial polygonal functions. In the interest of brevity, full details are not provided, and the interested reader should see the previous works of Floater and Lai [9] and Hackemack [10]. On a polygonal element, the reduced-space polygonal Bernstein–Bézier functions, { B p } , are formed by a set of functions with support points on vertices, along edges, and within the interior. They reduce to the Lagrange fundamental polynomials on triangles. For a n-gon and a finite element space of degree p, there are n vertex functions, p 1 functions along each edge, and ( p 1 ) ( p 2 ) 2 interior functions for a total of p n + ( p 1 ) ( p 2 ) 2 functions. They span the { x a y b } ( a + b ) p space of functions. Figure 1 gives the distribution of the degrees of freedom on an example pentagon for polynomial degrees p = 1 , 2 , 3 , 4 .

3.2. Extrusion to Polygonal Prisms

With the radial functions given, we can now provide details on converting them into an arbitrary-order functional space compatible with extruded polygonal prisms. For polynomial degree p, the extruded 3D functions, { E p } , are formed from the tensor product of the radial functions { B p } and the ( p + 1 ) 1D Lagrange polynomials (denoted as { L p } ):
E p ( x , y , z ) = B p ( x , y ) L p ( z ) .
For a polygonal prism with lower and upper bounds of z B and z T , respectively, the axial functions have evenly-spaced support points given by
z i = z B + i p ( z T z B ) , i = 0 , . . . , p ,
and the i-th axial function is given by
L p , i ( z ) = j = 0 j i p z z j z i z j , i = 0 , . . . , p .
Since these extruded functions are taken as the tensor product of our radial and axial functions, their functional space is given by span ( E p ) = { x a y b } { z c } , where dim ( E p ) = n p ( p + 1 ) + ( p + 1 ) ( p 1 ) ( p 2 ) / 2 (n still represents the number of vertices of the 2D polygon). The support points of the degrees of freedom are given in Figure 2 for an example pentagonal prism for polynomial degrees p = 1 , 2 , 3 . An analogous p = 4 case compared to Figure 1 was not provided due to the excessive cluttering of the nodes.

4. Numerical Results

4.1. Basis Function Verification

We first provide numerical experiments that verify properties of our extruded basis functions and the corresponding DGFEM transport solutions. We test three properties: (1) verify the DGFEM captures the proper interpolation space, (2) verify the DGFEM achieves proper convergence rates in h-type and p-type refinement, and (3) verify that the solutions maintain full resolution in the thick diffusion limit (TDL) [12].
We first test the interpolation properties and convergence rates of the S N solutions using the method of manufactured solutions (MMS). Our domain is [ 0 , 1 ] 3 , with σ t = 1 , σ s = 0 , S 8 quadrature, and all vacuum boundaries. We define two functional forms to test interpolation, ψ p , and convergence, ψ s , properties given by
ψ p ( x , y , z ) = c = 0 p ( a + b ) p x a y b z c , ψ s ( x , y , z ) = sin ( k x π x ) sin ( k y π y ) sin ( k z π z ) ,
with k x = 1 , k y = 2 , and k z = 3 . Three extruded mesh types are utilized: Cartesian (hexahedra), triangular, and polygonal. The 2D polygonal meshes were generated with the PolyMesher software [13] before extrusion. Table 1 gives the L 2 -norm of the error for DGFEM orders of p = 1 , . . . , 6 . From the machine precision results, we can clearly see that the transport solutions fully-live within the functional space of the polygonal Bernstein–Bézier functions. The loss of exact precision is due to the magnitude of the functions to grow past unity with increasing polynomial degree. Next, Figure 3 and Figure 4 provide the convergence of the sinusoidal solution, ψ s , under uniform h-refinement and p-refinement, respectively. Since N d o f h 3 in 3D, the slopes in Figure 3 approach ( p + 1 ) / 3 as expected. Additionally, since ψ s is analytic within r D , the exponential convergence of p-refinement in Figure 4 is expected.
Having verified the interpolation and convergence properties of our DGFEM scheme, we now confirm that our DGFEM transport solutions retain full resolution in the thick diffusion limit. From the work of Adams [12], it is known that a poor discretization of the S N transport equation (with full upwinding) leads to ‘locking’ into absurd transport solutions. Adams states that two properties of the DGFEM functions are needed for full resolution: (1) locality of the functions and (2) surface-matching (see Adams work for further details). The extruded polygonal prism functions of this work do possess these properties, and as such we expect full resolution.
In the TDL, the domain mean free path approaches infinity. If we fix the physical dimensions of the problem, we can then scale the cross sections and source to reflect the properties of the TDL. Introducing a scaling parameter, ϵ , we scale σ t as 1 / ϵ and σ a and Q as ϵ . This leads to a scaled transport equation and corresponding diffusion equation given by
Ω · ψ + 1 ϵ ψ = 1 ϵ ϵ ϕ 4 π + ϵ 4 π and ϵ 3 2 ϕ + ϵ ϕ = ϵ ,
respectively. The diffusion equation is discretized using a conforming Galerkin finite element method (CGFEM) with strongly-enforced homogeneous Dirichlet boundary conditions. As ϵ 0 , the discretized transport solution, ϕ T , will approach the discretized diffusion solution, ϕ D , at a rate of ϵ under the L 2 -norm ( | | ϕ D ϕ T | | L 2 ). This is confirmed in Figure 5.

4.2. Multigroup Pincell Problem

Our final numerical example is a 7 group pincell problem (with reflecting radial boundary conditions) that utilizes the geometry and cross sections of the UO 2 pincells from the C5G7 benchmark problem [14]. The fuel region is formed from a 16-sided regular polygon where the fine mesh cells are formed by square tiling until the pin boundary is intersected. The convergence history of the error in k (given in units of pcm) are given in Figure 6. Superior convergence is realized for increasing polynomial degree but with diminishing returns. A significant reduction in error is realized going from linear to quadratic FEM.

5. Conclusions

In this paper, we have presented an arbitrary-order DGFEM discretization of the S N transport equation compatible with extruded polygonal grids. The basis functions are formed by a tensor product of 2D radial ( x y ) polygonal Bernstein–Bézier functions and 1D axial (z) Lagrange polynomials. On an extruded n-gon with polynomial degree p, there are n p + ( p 1 ) ( p 2 ) / 2 radial functions and p + 1 axial functions, with their tensor product resulting in n p ( p + 1 ) + ( p + 1 ) ( p 1 ) ( p 2 ) / 2 total functions. These functions can exactly interpolate the { x a y b } { z c } space of functions, where a + b p and c = 0 , , p . Due to the locality and surface matching properties of the functions across edges, these functions allow for transport solutions to maintain full resolution in the thick diffusion limit. Numerical testing also demonstrated the functions’ interpolation properties and appropriate convergence rates were observed. The methodology presented in this work can thus be used to compute S N solutions on 3D extruded polygonal prisms (e.g., reactor analysis calculations).

Funding

This research received no external funding.

Institutional Review Board Statement

Not applicable.

Informed Consent Statement

Not applicable.

Data Availability Statement

The data presented in this study are available on request from the corresponding author.

Acknowledgments

The submitted manuscript has been authored by a contractor of the U.S. Government under contract No. DOE-89233018CNR000004. Accordingly, the U.S. Government retains a non-exclusive, royalty-free license to publish or reproduce the published form of this contribution, or allow others to do so, for U.S. Government purposes.

Conflicts of Interest

The authors declare no conflict of interest.

References

  1. Lewis, E.; Miller, W. Computational Methods of Neutron Transport; John Wiley and Sons, Inc.: New York, NY, USA, 1984. [Google Scholar]
  2. Reed, W.; Hill, T. Triangular Mesh Methods for the Neutron Transport Equation; Los Alamos Report LA-UR-73-479; Los Alamos Scientific Lab.: Los Alamos, NM, USA, 1973.
  3. Wang, Y.; Ragusa, J.C. On the convergence of DGFEM applied to the discrete ordinates transport equation for structured and unstructured triangular meshes. Nucl. Sci. Eng. 2009, 163, 56–72. [Google Scholar] [CrossRef]
  4. Hackemack, M.W. Higher-Order DGFEM Transport Calculations on Polytope Meshes for Massively-Parallel Architectures. Ph.D. Thesis, Texas A&M University, College Station, TX, USA, 2016. [Google Scholar]
  5. Stone, H.G.; Adams, M.L. New spatial discretization methods for transport on unstructured grids. In Proceedings of the ANS Topical Meeting Mathematics and Computation, Supercomputing, Reactor Physics and Biological Applications, Avignon, France, 12–15 September 2005. [Google Scholar]
  6. Bailey, T.S. The Piecewise Linear Discontinuous Finite Element Method Applied to the RZ and XYZ Transport Equations. Ph.D. Thesis, Texas A&M University, College Station, TX, USA, 2008. [Google Scholar]
  7. Hackemack, M.; Ragusa, J. Quadratic Serendipity Discontinuous Finite Element Discretization for SN Transport on Arbitrary Polygonal Grids. J. Comput. Phys. 2018, 374, 188–212. [Google Scholar] [CrossRef]
  8. Hackemack, M. Quadratic Serendipity Functions for DGFEM Transport on 2D Polygonal and 3D Extruded Polygonal Grids. In Proceedings of the PHYSOR 2018: Reactor Physics Paving the Way towards More Efficient Systems, Cancun, Mexico, 22–26 April 2018. [Google Scholar]
  9. Floater, M.; Lai, M.J. Polygonal spline spaces and the numerical solution of the Poisson equation. SIAM J. Numer. Anal. 2016, 54, 797–824. [Google Scholar] [CrossRef] [Green Version]
  10. Hackemack, M. Arbitrary-Order Discontinuous Galerkin Discretization for SN Transport Using Polygonal Bernstein-Bézier Functions. In Proceedings of the M&C 2019—International Conference on Mathematics & Computational Methods Applied to Nuclear Science & Engineering, Portland, OR, USA, 25–29 August 2019. [Google Scholar]
  11. Hackemack, M. Discontinuous Galerkin Solutions for Elliptic Problems on Polygonal Grids using Arbitrary-Order Bernstein-Bézier Functions. J. Comput. Phys. 2021, 437, 110293. [Google Scholar] [CrossRef]
  12. Adams, M.L. Discontinuous finite element transport solutions in thick diffusive problems. Nucl. Sci. Eng. 2001, 137, 298–333. [Google Scholar] [CrossRef]
  13. Talischi, C.; Paulino, G.H.; Pereira, A.; Menezes, I. PolyMesher: A general-purpose mesh generator for polygonal elements written in Matlab. Struct. Multidiscip. Optim. 2012, 45, 309–328. [Google Scholar] [CrossRef]
  14. Dahl, J. PARTISN results for the OECD/NEA 3-d extension C5G7 MOX benchmark. Prog. Nucl. Energy 2006, 48, 401–409. [Google Scholar] [CrossRef]
Figure 1. Degrees of freedom of the 2D radial functions on a polygonal element. Black, blue, and red nodes correspond to vertex, edge, and interior functions, respectively.
Figure 1. Degrees of freedom of the 2D radial functions on a polygonal element. Black, blue, and red nodes correspond to vertex, edge, and interior functions, respectively.
Jne 02 00022 g001
Figure 2. Degrees of freedom on an extruded polygonal element. Black, blue, green, and red nodes correspond to vertex, edge, face, and interior functions, respectively.
Figure 2. Degrees of freedom on an extruded polygonal element. Black, blue, green, and red nodes correspond to vertex, edge, face, and interior functions, respectively.
Jne 02 00022 g002
Figure 3. L2-norm of the error under uniform h-refinement for the sinusoidal problem.
Figure 3. L2-norm of the error under uniform h-refinement for the sinusoidal problem.
Jne 02 00022 g003
Figure 4. L 2 -norm of the error under uniform p-refinement for the sinusoidal problem.
Figure 4. L 2 -norm of the error under uniform p-refinement for the sinusoidal problem.
Jne 02 00022 g004
Figure 5. Convergence rates for the thick diffusion limit problem in terms of ϵ.
Figure 5. Convergence rates for the thick diffusion limit problem in terms of ϵ.
Jne 02 00022 g005
Figure 6. Convergence rates in k e f f for the pincell problem.
Figure 6. Convergence rates in k e f f for the pincell problem.
Jne 02 00022 g006
Table 1. L 2 -norm of the error in the monomial solutions on the different mesh types.
Table 1. L 2 -norm of the error in the monomial solutions on the different mesh types.
pCartesianTriangularPolygonal
18.97 × 10 16 8.10 × 10 16 8.81 × 10 16
23.86 × 10 15 2.66 × 10 15 5.36 × 10 15
37.52 × 10 15 5.71 × 10 15 9.24 × 10 15
41.33 × 10 14 9.89 × 10 15 5.50 × 10 14
55.74 × 10 14 4.97 × 10 14 8.88 × 10 14
61.04 × 10 13 8.80 × 10 14 2.19 × 10 13
Publisher’s Note: MDPI stays neutral with regard to jurisdictional claims in published maps and institutional affiliations.

Share and Cite

MDPI and ACS Style

Hackemack, M. Arbitrary-Order Bernstein–Bézier Functions for DGFEM Transport on 3D Polygonal Grids. J. Nucl. Eng. 2021, 2, 239-245. https://0-doi-org.brum.beds.ac.uk/10.3390/jne2030022

AMA Style

Hackemack M. Arbitrary-Order Bernstein–Bézier Functions for DGFEM Transport on 3D Polygonal Grids. Journal of Nuclear Engineering. 2021; 2(3):239-245. https://0-doi-org.brum.beds.ac.uk/10.3390/jne2030022

Chicago/Turabian Style

Hackemack, Michael. 2021. "Arbitrary-Order Bernstein–Bézier Functions for DGFEM Transport on 3D Polygonal Grids" Journal of Nuclear Engineering 2, no. 3: 239-245. https://0-doi-org.brum.beds.ac.uk/10.3390/jne2030022

Article Metrics

Back to TopTop