Fact-checked by Grok 2 weeks ago

Mesh generation

Mesh generation, also known as meshing, is the process of discretizing a continuous geometric —such as a surface or —into a of interconnected elements, typically triangles, quadrilaterals, tetrahedra, or hexahedra, to approximate the geometry for numerical simulations. This technique forms the foundation of computational methods like finite element analysis (FEA) and (CFD), enabling the solution of partial differential equations (PDEs) that model physical phenomena in and scientific applications. The primary goal of mesh generation is to create a mesh that balances accuracy, computational efficiency, and fidelity to the original geometry, as poor mesh quality can lead to numerical instabilities, slow convergence, or inaccurate results. Meshes are categorized into structured, unstructured, and hybrid types: structured meshes use regular, grid-like arrangements (e.g., Cartesian or curvilinear grids) ideal for simple geometries and methods like finite differences; unstructured meshes employ irregular elements (e.g., varying triangles or tetrahedra) for complex shapes, offering flexibility but potentially higher computational demands; hybrid meshes combine both to optimize performance in regions of varying geometric complexity. Key steps in mesh generation include defining the input , cleaning and repairing any imperfections (e.g., gaps or overlaps in CAD models), partitioning the domain into elements via automated algorithms or manual intervention, and refining the mesh through techniques like adaptive refinement to improve in critical areas. quality is evaluated using metrics such as (ratio of longest to shortest edge lengths, ideally close to 1), (deviation from ideal shape), and determinant (ensuring positive volume for stability). Applications of mesh generation are widespread, including structural integrity assessments in and , flow simulations around vehicles or turbines in CFD, electromagnetic field analysis, and even 3D modeling in and for geometric data processing. Despite advances in automated tools, challenges persist in handling highly intricate geometries, ensuring scalability for large-scale simulations, and minimizing human intervention to reduce time and error.

Fundamentals

Definition and Importance

Mesh generation is the process of discretizing a continuous geometric domain into a finite number of simpler subdomains, known as elements, to enable numerical analysis through methods such as the finite element method (FEM) or finite volume method. This discretization divides complex geometries into manageable computational units, typically comprising nodes (vertices), elements (cells like triangles or hexahedra), and connectivity data that define their relationships. The origins of mesh generation trace back to the , coinciding with the emergence of FEM for solving problems, where early applications focused on dividing aircraft components into triangular elements for stress analysis. A pivotal advancement occurred in the through NASA's research on structured grid generation for aerodynamic simulations, notably Joe F. Thompson's development of boundary-fitted curvilinear coordinate systems that allowed meshes to conform to arbitrary physical boundaries. Mesh generation plays a vital role in computational simulations by facilitating the approximation of partial differential equations (PDEs) across disciplines, including (CFD) for flow prediction, electromagnetics for wave propagation modeling, and for tissue . High-quality meshes enhance accuracy by minimizing numerical errors, while optimized improves computational ; however, poor meshes can lead to unreliable results or excessive demands. Major challenges in mesh generation revolve around balancing element quality—such as and skewness—to ensure fidelity, controlling overall size to fit computational budgets, and reducing generation time for practical workflows, particularly in large-scale or adaptive applications.

Terminology

In generation, fundamental components include nodes, also known as vertices, which are discrete points in the geometric that serve as the basic building blocks for . Edges connect pairs of nodes, forming the one-dimensional boundaries within the mesh structure. Faces are two-dimensional polygonal surfaces composed of multiple edges, bounding higher-dimensional in three-dimensional meshes. Cells, interchangeably referred to as elements, are the volumetric or areal units that tessellate the , typically taking the form of simplices such as triangles or tetrahedra, or polyhedra like quadrilaterals and hexahedra. describes the topological relationships among these components, often represented using adjacency lists or graphs to encode how nodes link to edges, faces, and cells. Meshes are classified based on their and properties. Structured meshes feature regular where interior nodes have neighborhoods, typically using or hexahedral for efficient indexing. In contrast, unstructured meshes allow nodes to have varying local neighborhoods, employing triangular or tetrahedral to accommodate complex geometries. Conformal meshes ensure that adjacent share complete faces or edges without gaps or overlaps at . Non-conformal meshes, also known as overlapping or hanging-node meshes, permit partial matches between element boundaries, which can introduce complexities but allow greater flexibility. Hybrid meshes integrate structured and unstructured regions, often using prismatic or layered near boundaries and unstructured fills elsewhere. Mesh quality is evaluated through metrics that quantify element shape and distortion to ensure and accuracy. The aspect ratio measures the elongation of an element by comparing its longest to shortest edge lengths, with values near 1 indicating equilateral or cubic ideals and higher values signaling potential gradient smearing. Skewness assesses angular deviation from equiangular ideals, penalizing non-orthogonal corners that can introduce numerical diffusion in simulations. Orthogonality evaluates the alignment of element edges or faces relative to connecting lines between cell centers, where near-90-degree angles minimize errors in flux computations. The Jacobian determinant determines element validity by computing the of the from reference to physical space; positive values confirm non-inverted orientations, while values near zero indicate degeneracy or negative volumes. Specific variants of meshing address domain dimensionality and flow characteristics. Surface meshing discretizes two-dimensional boundary geometries into triangular or elements to represent interfaces accurately. Volume meshing extends this to three-dimensional interiors, filling domains with tetrahedral, pyramidal, prismatic, or hexahedral elements to enable full . Boundary-layer meshing, prevalent in , generates finely spaced prismatic or layered elements adjacent to walls to capture steep velocity gradients in near-wall regions.

Cell Topology

In mesh generation, cell topology describes the abstract combinatorial structure governing the connectivity of vertices, edges, faces, and cells, devoid of any geometric or positioning. This structure forms a cell complex where lower-dimensional elements (such as edges and faces) serve as boundaries of higher-dimensional cells, ensuring proper rules: any two cells intersect either in a shared lower-dimensional face or not at all. Fundamental rules dictate the validity of this topology, including the Euler characteristic, a topological invariant that for manifold meshes satisfies the relation V - E + F - C = \chi, where V denotes the number of vertices, E the number of edges, F the number of faces, C the number of cells ( volumes), and \chi depends on the domain's topology (e.g., \chi = 1 for a domain homeomorphic to a ; for a surface mesh, the formula is V - E + F = \chi, with \chi = 2 - 2g - b for genus g and b boundaries). Meshes are classified as simplicial complexes, in which every cell is a with the minimal number of bounding faces (e.g., three edges per face in ), or non-simplicial (polyhedral) complexes, which permit cells with arbitrary numbers of faces for greater flexibility in complex domains. Representative examples of simplicial topologies include the triangular mesh in 2D, where each face is bounded by three edges forming a , and the tetrahedral mesh in 3D, with each cell bounded by four triangular faces. In contrast, polyhedral topologies encompass non-simplicial elements such as hexahedra (six quadrilateral faces) or prisms, often generated by extruding quadrilateral surface meshes to accommodate arbitrary face counts per cell. Topological validation ensures consistency through checks like the manifold property, requiring every interior edge to be shared by exactly two faces and every vertex to be incident to a consistent of adjacent faces, alongside uniform orientation where face normals point consistently outward across the . These verifications, often integrated into mesh generation pipelines, detect inconsistencies such as non-manifold edges or inverted orientations that could compromise numerical simulations.

Mathematical Foundations

Cell Dimensions

In , mesh cells are defined as line segments connecting two nodes, discretizing the domain into a sequence of intervals for purposes. These cells form the basic building blocks for solving differential equations along a line, with the of each segment determining local . In two dimensions, mesh cells commonly consist of triangles or quadrilaterals. Triangles are constructed from three nodes forming a planar figure, providing flexibility in adapting to curved boundaries. Quadrilaterals, built from four nodes, require planarity for accurate and edge alignment to maintain shape regularity and avoid distortion in the mesh. In three dimensions, cells include tetrahedra, hexahedra, prisms, and pyramids. Tetrahedra are formed by four nodes with triangular faces, hexahedra by eight nodes with quadrilateral faces, prisms by six nodes combining triangular and quadrilateral faces, and pyramids by five nodes with a quadrilateral base and triangular sides. The volume of these cells, such as tetrahedra, is computed using determinants; for a tetrahedron with vertices \mathbf{v}_0, \mathbf{v}_1, \mathbf{v}_2, \mathbf{v}_3, the signed volume V is V = \frac{1}{6} \det \begin{pmatrix} x_1 - x_0 & x_2 - x_0 & x_3 - x_0 \\ y_1 - y_0 & y_2 - y_0 & y_3 - y_0 \\ z_1 - z_0 & z_2 - z_0 & z_3 - z_0 \end{pmatrix}, where (x_i, y_i, z_i) are the coordinates of \mathbf{v}_i, and the absolute value yields the unsigned volume. For higher dimensions, cells are generalized as n-simplices, the convex hulls of n+1 affinely independent points, applied in theoretical mesh generation for manifolds beyond three dimensions, such as 4D unit ball discretizations. These extend the simplex concept from lines (1D), triangles (2D), and tetrahedra (3D) to arbitrary n. Dimensional consistency requires that lower-dimensional boundaries, such as edges and faces, precisely match the facets of higher-dimensional cells, forming a coherent across the . This ensures conformity and valid topological connections, as established in cell topology frameworks.

Duality

In generation, the provides a complementary structure to the , where vertices of the dual correspond to the cells (or elements) of the primal , and edges in the dual connect vertices if the corresponding primal cells share a face, thereby encoding . This relational mapping facilitates analysis of mesh connectivity without directly manipulating the primal geometry. The can be constructed geometrically by placing dual vertices at the centroids or circumcenters of primal cells and connecting them across shared faces, or abstractly as a where the represents cell neighborhoods. A notable example of dual construction arises in Voronoi-based meshes, where the primal Voronoi diagram—partitioning space into cells around seed points—has a dual in the Delaunay triangulation, connecting seeds whose Voronoi cells adjoin, ensuring empty circumcircles for maximal minimality in triangle angles. In graph-theoretic terms, the dual's adjacency matrix is derived from the primal's face-sharing relations, enabling efficient traversal and storage of mesh topology. Key properties of dual meshes include their topological complementarity: in two dimensions, the dual of a triangular primal mesh forms a hexagonal structure, as each primal vertex of degree six corresponds to a hexagonal dual cell, promoting balanced valence in regular tilings. These properties extend to higher dimensions, preserving Euler characteristics and supporting hybrid primal-dual analyses. Dual meshes find applications in flow visualization, where they enable streamline tracing between cell centers on unstructured grids for coherent vector field rendering, and in error estimation, leveraging duality techniques to bound residuals and guide adaptive refinement in finite element solutions. The benefits of dual meshes lie in computational efficiency: by representing neighborhoods explicitly via the , they simplify neighbor searches during and in solvers, reducing query times from O(n) brute-force scans to O() local lookups. Additionally, dual formulations aid handling by distinguishing interior adjacencies from boundary conditions, streamlining computations and load balancing in environments without repeated traversals.

Definitions and Variants

In mesh generation, a is formally defined as a or CW-complex over a \Omega \subset \mathbb{R}^d, represented by a T = \{K_i\} where the cells K_i are simplices (such as triangles in or tetrahedra in ) whose union covers \Omega exactly, i.e., \bigcup K_i = \Omega. This structure ensures a topological decomposition suitable for numerical methods like the (FEM), where the mesh discretizes the domain into manageable geometric primitives. Key variants of meshes include conforming, quasi-uniform, and anisotropic types, each tailored to specific computational needs. A conforming mesh requires that the interiors of distinct cells do not overlap and their union precisely covers \Omega, with any intersection of two cells being either empty or a shared lower-dimensional face (e.g., an edge or vertex). Quasi-uniform meshes maintain bounded aspect ratios across elements, typically defined such that there exists a constant \gamma > 0 where \gamma^{-1} h \leq h_K \leq \gamma h for all cells K \in T, with h as the global mesh size and h_K the local size, ensuring nearly equitable element distribution. Anisotropic meshes, in contrast, feature elements stretched along prescribed directions to align with solution features like gradients or flows, often generated via metric-based adaptations that elongate simplices in anisotropic spaces. The mesh size function h(x) quantifies local and is defined as h(x) = \sup \{ \operatorname{diam}(K) \mid x \in K, K \in T \}, where \operatorname{diam}(K) is the of K. Refinement criteria often impose h(x) \leq \varepsilon for a prescribed \varepsilon > 0 to achieve desired accuracy in approximations. For in FEM and (CFD), shape-regularity is essential, requiring that the maximum \sigma = \max_{K \in T} \frac{\operatorname{diam}(K)}{\rho_K} remains bounded by a constant independent of the mesh size, where \rho_K is the inradius of K. This condition prevents degenerate elements and ensures stable inverse inequalities, enabling optimal error estimates like O(h^k) for polynomial degree k.

Core Techniques

Algebraic Methods

Algebraic methods in mesh generation rely on explicit mathematical mappings to transform a simple computational domain, such as a rectangular or cubic region in parametric space, into a physical , producing structured grids without solving equations. These techniques, particularly transfinite , enable direct interpolation between boundary curves or surfaces to fill the interior with grid points, ensuring conformity to the geometry. Originating in the early 1970s, algebraic approaches were among the first systematic methods for generating body-fitted coordinates in (CFD), offering computational efficiency for problems where boundary data is well-defined. Transfinite interpolation (TFI) is the cornerstone of algebraic grid generation, extending univariate interpolation to multiple dimensions by blending contributions from all boundaries using Boolean summation principles. In one dimension, a basic linear coordinate transformation maps the physical coordinate x to a parametric coordinate \xi via the equation \xi = \frac{x - x_{\min}}{x_{\max} - x_{\min}}, where x_{\min} and x_{\max} define the domain endpoints; this ensures uniform spacing in \xi corresponds to the physical extent. For multi-dimensional cases, TFI generalizes this using blending functions, such as Lagrange polynomials for linear interpolation (\phi_0(\xi) = 1 - \xi, \phi_1(\xi) = \xi) or Hermite cubics for smoother transitions that incorporate boundary tangents. The general form for a 2D bilinear TFI is given by: \mathbf{x}(\xi, \eta) = (1-\xi)(1-\eta) \mathbf{x}(0,0) + \xi(1-\eta) \mathbf{x}(1,0) + (1-\xi)\eta \mathbf{x}(0,1) + \xi\eta \mathbf{x}(1,1), where \mathbf{x} represents position vectors on the boundaries, and this extends to higher dimensions by successive univariate blends. These methods produce orthogonal or near-orthogonal grids by enforcing boundary conditions directly, with Hermite variants allowing control over grid spacing near surfaces for better resolution. Algebraic methods excel in applications requiring rapid generation of structured meshes over simple or mildly curved domains, such as in aerodynamic simulations, where TFI can create conformal grids around profiles like the M6 wing for flow analysis. Their primary advantage lies in speed, as the explicit formulas avoid iterative solvers, enabling grid generation in seconds to minutes even for cases, which was critical in early CFD workflows. For instance, these techniques facilitated body-fitted coordinates in airfoil computations during the , supporting simulations in codes like those developed by et al. However, limitations include poor adaptability to complex, irregular geometries, where distortions may lead to overlapping or negative cells without sub-domain decomposition; thus, they are best suited for simple domains, though still used in modern applications where speed is prioritized over flexibility. These methods continue to serve as a foundation in hybrid approaches, including integration with for automated grid initialization in contemporary simulations.

Variational Methods

Variational methods in mesh generation involve optimizing an energy-like functional to produce smooth, high-quality grids that adapt to the underlying and features. These approaches treat the as the solution to a variational problem, where positions are determined by minimizing a that balances smoothness and equidistribution of elements. The resulting meshes exhibit low distortion and , making them particularly effective for structured or semi-structured grids in computational simulations. The core framework minimizes a functional of the form J[T] = \int_{\Omega} W(\nabla u) \, d\Omega, where T represents the mapping, \Omega is the domain, u is a monitor function that encodes desired (e.g., based on error estimates or ), and W is a such as the trace of the metric-weighted , ensuring element sizes and orientations align with the monitor. For instance, the seminal Winslow functional is defined as I[\xi] = \frac{1}{2} \int_{\Omega} \operatorname{tr}(J M^{-1} J^T) \, dx, where \xi is the mapping from physical to computational space, J is the matrix, and M is a symmetric positive definite derived from the monitor function. Minimization of this functional yields Euler-Lagrange equations that correspond to elliptic partial differential equations (PDEs) governing the positions, such as g^{ij} \partial_i \partial_j x^k = 0 for physical coordinates x^k, where g^{ij} is the contravariant ; these PDEs promote smooth transitions and can be solved iteratively using finite differences or finite elements. In discrete settings, optimization often employs analogies like a spring network, where edges act as torsional springs with inversely proportional to edge length, and positions minimize the total E = \frac{1}{2} \sum_{edges} k_e (\theta_e - \theta_e^0)^2, solved via linear systems for efficient deformation. Variational methods are classified into and types. Inverse methods compute a from a computational to the physical domain by minimizing the functional on the Jacobian, effectively "pulling back" an equidistant to conform to boundaries while preserving smoothness, as pioneered by Winslow for problems on triangular meshes. Direct methods, in contrast, optimize node positions and element shapes directly in physical space using functionals that penalize distortion metrics, such as deviations from equilateral shapes, allowing greater flexibility for irregular domains. These connect to elliptic PDE schemes through their shared reliance on Laplace-like equations for control. The advantages of variational methods include the generation of meshes with minimal and high , reducing numerical in simulations; they are widely applied in and aerodynamic contexts, such as high-order unstructured curved meshes for viscous flows around airfoils, where they achieve to layers with low distortion. For example, solving the Winslow equations via continuous Galerkin methods on unstructured simplices yields meshes with improved for finite compared to algebraic alternatives.

Unstructured Grid Generation

Unstructured grid generation encompasses algorithms that produce meshes with arbitrary connectivity, allowing flexible adaptation to complex geometries without imposing a regular pattern. These methods typically start from a set of points and boundaries, constructing elements through local decisions rather than global mappings. Prominent approaches include , which maximizes the minimum angle in triangles to ensure quality, and the advancing front technique, which builds the mesh incrementally from domain boundaries. Delaunay triangulation defines a mesh where no point lies inside the circumsphere of any , known as the empty sphere criterion; formally, for a with vertices a, b, c, its circumsphere contains no other points from the vertex set in its interior. This criterion, combined with the max-min angle optimization—ensuring all angles are at least a user-specified \theta (typically 20°–30°)—produces well-shaped elements with bounded aspect ratios, often no worse than $2 / \sin \theta. A key procedure is the Ruppert algorithm, which refines the mesh by iteratively inserting points: it identifies skinny s (small angles) or encroached boundary segments, then places new vertices at circumcenters or midpoints to eliminate these features while maintaining the Delaunay property. To ensure conformity with input boundaries, edge flipping is employed: non-locally Delaunay edges (where the formed by adjacent triangles has a better alternative diagonal) are swapped, transforming the until the empty sphere condition holds globally. This local insertion and flipping process generates from scratch, relying on combinatorial operations rather than optimization or PDEs. The advancing front method constructs the mesh layer by layer, beginning with a discretized surface and propagating inward by creating new adjacent to the current "front" of unresolved edges or faces. At each step, the algorithm selects the shortest edge on the front, connects it to a new point positioned to form a valid (e.g., or ) while respecting spacing controls and , then updates the front by removing the used edge and adding new ones. This boundary-to-interior progression naturally handles irregular shapes, producing prismatic layers near surfaces for better resolution. These techniques find applications in simulating complex geometries, such as urban (CFD), where unstructured meshes efficiently capture building clusters and street canyons without excessive elements. Software like TetGen implements Delaunay-based generation for 3D tetrahedral meshes, developed in the early 2000s and evolving to support constrained refinement for polyhedral domains in scientific computing. Unstructured grids can integrate briefly with adaptive refinements to locally increase resolution in high-gradient regions.

Partial Differential Equation Methods

Elliptic Schemes

Elliptic schemes for mesh generation rely on solving (PDEs) of the elliptic type to produce smooth, boundary-conforming grids that exhibit desirable properties such as and minimal . These methods transform the physical into a computational by defining coordinate lines that satisfy specific PDEs, ensuring the generated adapts smoothly to complex geometries. The approach is particularly effective for structured , where the elliptic nature promotes a diffusion-like behavior that distributes grid points evenly while respecting boundary conditions. The governing equations for elliptic mesh generation are typically the Laplace equation \nabla^2 \xi = 0 or the more general Poisson equation \nabla^2 \xi = P(\xi), where \xi represents the coordinate lines in the computational space and P(\xi) is a control that allows for local adjustments in grid spacing and orientation to achieve desired clustering or smoothness. These equations are inverted from the physical to the computational coordinates, ensuring that the preserves the elliptic character and produces orthogonal grids when appropriate. The control P(\xi) can be derived from user-specified distributions or automatically computed to enforce properties like equidistribution of grid point density. To solve these PDEs, finite difference or finite volume discretizations are commonly employed on a coarse initial grid, transforming the continuous equations into a system of algebraic equations. Iterative solvers, such as successive over-relaxation or advanced techniques like multigrid methods, are then used to converge to the solution efficiently, often achieving grid independence and high accuracy in complex domains. Multigrid approaches accelerate convergence by employing a hierarchy of grids, smoothing errors at multiple levels to handle the stiffness inherent in elliptic systems. A key advantage of elliptic schemes is their diffusion-like smoothing, which propagates boundary information throughout the domain, preventing grid overlaps and folds while promoting interior uniformity. This makes them ideal for internal grid smoothing in regions away from boundaries, where global equilibrium is achieved without directional bias. The resulting meshes exhibit high quality, with smooth variation in cell sizes and angles close to 90 degrees, enhancing numerical stability in simulations. The foundational work on elliptic schemes was introduced by Winslow in 1967, who developed a for solving the on nonuniform triangular meshes, laying the groundwork for modern structured grid generation. This method has been widely applied in two-dimensional airfoil meshing, where it generates high-resolution grids around aerodynamic shapes, capturing boundary layers and wakes with minimal distortion for analyses. Winslow's approach demonstrated superior smoothing compared to earlier algebraic methods, influencing subsequent developments in both structured and unstructured contexts.

Hyperbolic Schemes

Hyperbolic schemes in mesh generation utilize hyperbolic partial differential equations (PDEs) to create structured by propagating coordinate lines outward from specified surfaces in a manner. These methods, pioneered in the late 1970s and early 1980s, enable rapid generation of body-fitted suitable for (CFD) simulations where directional control from boundaries is prioritized. Unlike global solvers, hyperbolic approaches treat grid points as wavefronts advancing along characteristics, ensuring efficient computation without requiring domain-wide iterations. The core equations form a first-order hyperbolic system, exemplified by ∂ξ/∂s + a · ∇ξ = 0, where ξ represents a computational coordinate, s denotes the marching direction normal to the boundary, and a is a vector field dictating the propagation speed and direction to enforce grid spacing and orthogonality. This advection-like equation ensures that coordinate values are transported along characteristic curves originating from the boundary data. Equivalent formulations impose constraints on grid orthogonality (e.g., r_ξ · r_η = 0) and cell volume or arc length (e.g., |r_ξ| = Δs), transforming into a hyperbolic system marched in the η-direction. Solutions are obtained using upwind schemes, which discretize the PDEs in an implicit manner along the direction to maintain and accuracy. These schemes leverage the nature by evaluating derivatives upwind relative to the characteristic curves, allowing non-iterative advancement of grid layers from the initial boundary mesh; for instance, block-tridiagonal solvers handle the coupled for second-order accuracy in the coordinate. The characteristic curves serve as paths for information propagation, ensuring that boundary conditions directly influence interior points without . Key properties include computational efficiency, as grids can be generated in a single pass with low memory overhead, often completing complex configurations in seconds to minutes on modern hardware. They naturally support resolution by specifying variable marching steps Δs for clustering near walls, achieving near-orthogonality and smooth variation in cell sizes. However, in boundary regions, improper specification of the propagation vector a can cause grid lines to intersect, leading to tangling; mitigation involves functions or limited-angle constraints. Elliptic may be applied post-generation to resolve minor distortions. Applications encompass extrusion-based meshing, where 2D boundary grids are marched normal to surfaces to form 3D volumes, ideal for prismatic layers around airfoils or bodies. Since the 1980s, these schemes have been integral to simulations, generating C-type or O-type grids around blade passages for viscous flow analysis, with examples demonstrating improved solver convergence in CFD workflows.

Parabolic Schemes

Parabolic schemes in mesh generation employ parabolic partial differential equations (PDEs) solved via in a specified to generate structured or semistructured grids, combining directional with transverse . Introduced by Nakamura in , these methods parabolize elliptic systems by eliminating second derivatives in the marching direction, enabling efficient non-iterative advancement from an initial boundary. The governing equation takes a quasi-linear form such as \frac{\partial \xi}{\partial s} = \nabla_\perp^2 \xi, where \xi represents the computational coordinates, s is the marching normal to the boundary, and \nabla_\perp^2 is the Laplacian in the transverse physical directions. Solutions to these parabolic PDEs are obtained using marching finite difference methods, advancing the grid layer-by-layer from an initial boundary condition. Explicit or implicit schemes update coordinates based on previous layers, with implicit methods solving tridiagonal systems for in the marching direction. Adaptive step sizes based on stability criteria, such as the CFL condition, prevent oscillations, especially near high-curvature boundaries. These approaches are computationally efficient, often one to two orders of magnitude faster than full elliptic solvers, due to the unidirectional without global iterations. Parabolic schemes inherit the rapid advancement of hyperbolic methods while incorporating transverse diffusion for improved smoothness, resulting in meshes that avoid severe folding and maintain quality in moderately complex geometries. This makes them suitable for applications like semistructured grids in . In moving boundary problems, such as free-surface flows, parabolic methods generate adaptive grids that track interface motion while preserving near-orthogonality. Extensions in the 1990s, such as semistructured three-dimensional marching schemes, refined these techniques for viscous flow simulations around aircraft components, enhancing resolution.

Advanced and Specialized Techniques

Adaptive Methods

Adaptive methods enable the dynamic refinement or coarsening of meshes during numerical simulations to concentrate resolution where solution accuracy is most needed, such as near singularities or steep gradients, thereby optimizing computational efficiency. These approaches rely on error estimation frameworks to guide adaptations, primarily through error estimators that assess the discrepancy between the computed solution and a more accurate approximation after solving the governing equations. A seminal example is the Zienkiewicz-Zhu estimator for finite element methods (FEM), which recovers improved gradients from superconvergent nodal values and computes local error indicators as the difference between recovered and original solutions. This recovery-based technique has been widely adopted due to its simplicity and effectiveness in practical engineering analyses. Another key framework is goal-oriented adaptation, which focuses error control on specific quantities of interest, such as drag coefficients in , by employing adjoint problems to propagate errors from the residual to the targeted functional. This dual-weighted residual approach, developed by and Rannacher, ensures efficient resource allocation toward user-defined objectives rather than global norms. Core algorithms in adaptive meshing include h-refinement, which locally reduces element size to increase resolution; p-refinement, which elevates the polynomial order of basis functions within elements; and r-refinement, which repositions nodes to cluster them in high-error regions without altering . These strategies can be combined in - or r-adaptive schemes to exploit the exponential convergence of higher-order methods while maintaining flexibility for complex geometries. h-refinement is particularly suited for capturing discontinuities like shocks, as it allows straightforward subdivision of elements, whereas p-refinement enhances smoothness in smooth regions, and r-refinement preserves during movement. The adaptation procedure typically involves an iterative cycle of solving the problem on the current , estimating local , marking for refinement, and generating a new , followed by solution transfer and re-solving until criteria are met. are marked for refinement using strategies like the Dörfler bulk criterion, which selects a minimal set of where the sum of indicators exceeds a η (typically 20-35%) of the total estimated , ensuring efficient global reduction. This marking promotes quasi-optimal rates in adaptive FEM by balancing refinement bulk with computational cost. Solution variables are then interpolated or projected onto the adapted to initialize the next solve-adapt iteration, often requiring conservative reconstruction for in transport-dominated problems. In applications, h-adaptive methods are extensively used in (CFD) to resolve shock waves, where localized refinement prevents numerical and improves shock sharpness without excessive global resolution. A historical milestone is the Berger-Oliger for adaptive mesh refinement in hyperbolic partial differential equations, introduced in 1984, which employs hierarchical grids to refine both spatially and temporally around estimated error regions, enabling accurate simulation of time-dependent shocks in gas dynamics. These techniques, applicable to unstructured grids, have significantly advanced simulations of transonic and supersonic flows by achieving high-fidelity results with reduced compared to uniform meshes.

Image-Based Meshing

Image-based meshing involves the automated creation of computational meshes directly from volumetric image data, such as those obtained from medical scans or scanned geometries, enabling simulations in fields like without relying on explicit geometric models. This approach typically begins with to delineate regions of interest, followed by surface extraction and volume meshing to produce elements suitable for finite element analysis. By leveraging the inherent or structure of images, it facilitates the generation of unstructured meshes that conform to complex, irregular boundaries. The core process starts with segmentation of voxels or pixels to identify boundaries and internal structures within the image data. Segmentation often employs thresholding, region-growing, or deformable models like to separate materials or tissues based on intensity levels, producing labeled volumetric data that defines the geometry. Isosurface extraction then converts this segmented data into a triangular surface using algorithms that scan the volume cell by cell. A seminal technique is the algorithm, which divides the image into cubic cells, evaluates scalar values at vertices relative to an isovalue, and generates triangles via a lookup table of 256 configurations (reduced to 15 by ) to approximate the surface. This method, introduced in , provides sub-voxel accuracy through and has been foundational for extracting high-resolution surfaces from medical volumes. Key algorithms for image-based meshing include for representing and applied to point clouds derived from images. define the geometry via a φ(x), where the zero {x | φ(x) = 0} captures the boundary; meshes are generated by iteratively refining an initial triangulation through force equilibrium on edges, with nodes projected onto the using approximations like φ/|∇φ| for boundary alignment. This approach excels in handling topological changes and complex features in image data, such as those from scans, by adapting mesh size to (h(x) ≤ 1/|κ(x)|) and feature size. For point clouds extracted from stereo images or , constructs a tetrahedral mesh by ensuring no point lies inside the circumsphere of any , often combined with checks to filter extraneous elements and produce watertight surfaces. Significant challenges in image-based meshing arise from , limited , and the need for elements in applications like . in CT or MRI data can introduce artifacts during segmentation, leading to irregular surfaces that propagate errors into the ; constraints often result in voxelization effects, where staircasing distorts smooth boundaries and complicates tetrahedralization. In medical contexts, generating tetrahedral meshes from /MRI scans for biomechanical simulations requires handling multi-label regions (e.g., 56 structures) while ensuring and minimal element , often necessitating post-processing like active surface to fidelity and smoothness. These issues demand robust preprocessing, such as morphological filtering, to mitigate partial volume effects and achieve meshes with element counts in the millions for detailed neuroanatomical models. Developments in image-based meshing trace back to the late 1980s with the algorithm, which saw extensive refinements in the , including ambiguity resolution via asymptotic deciders and extensions to multi-resolution structures for efficient processing of large volumes. Modern advancements integrate these techniques with CAD systems for , where scanned image data is segmented and meshed to produce editable parametric models, enabling applications in and prototyping by combining voxel-based extraction with surface fitting. Adaptive refinement may be briefly applied to correct artifacts from , enhancing mesh quality without altering the core data-driven process.

Machine Learning Methods

Machine learning methods have emerged as a transformative approach in mesh generation, leveraging data-driven models to automate the creation of high-quality meshes for complex geometries, particularly in computational simulations and . These techniques often process input data such as point clouds or boundary representations to predict mesh structures, surpassing traditional algorithmic methods in handling irregular and high-dimensional domains by learning patterns from large datasets. As of 2025, the field emphasizes scalable, efficient models that integrate neural architectures to generate unstructured or adaptive meshes, reducing manual intervention while maintaining fidelity for applications in finite element analysis and . Key techniques include neural networks tailored for point cloud prediction, which convert sparse or noisy point sets into coherent mesh surfaces. For instance, architectures like PointNet++ employ hierarchical feature extraction to capture local and global geometric details from point clouds, enabling robust and meshing even in the presence of occlusions or incomplete data. Autoregressive models further advance this by enabling progressive refinement, where meshes are generated iteratively through next-level-of-detail predictions, starting from coarse representations and refining toward finer topologies in a sequential manner. This autoregressive paradigm, inspired by image generation models, allows for controllable detail addition, making it suitable for scalable content creation. Prominent examples illustrate the practical impact of these methods. NVIDIA's Meshtron, introduced in 2024, utilizes a transformer-based to generate high-fidelity 3D meshes directly from images or sketches, achieving up to 64,000 faces with artist-level detail at times under a second on modern GPUs, demonstrating scalability for real-time applications. Graph s (GNNs) have also been pivotal in , where models like AdaptNet learn to generate and adapt meshes by propagating features across graph representations of geometric entities, optimizing for structural integrity in additive manufacturing and simulations. Recent advances highlight efficiency and integration trends as of 2025. Green approaches leverage prior to predict near-optimal distributions, minimizing computational overhead by training on historical meshes to forecast spacing functions that balance accuracy and resource use, aligning with sustainable computing goals in large-scale workflows. of generative adversarial networks (GANs) enhances , where discriminators evaluate and refine generated meshes for metrics like element and , as seen in MeshGAN variants that operate intrinsically on surfaces to mitigate artifacts in complex topologies. These methods offer significant benefits, including superior scalability to intricate domains like fractured surfaces or turbulent flows, where they outperform classical techniques in generation speed—often by orders of magnitude for irregular geometries—while producing meshes with lower . However, challenges persist, notably the substantial requirements for robust models, which demand diverse, labeled mesh sets to generalize across varying geometries, and the need for interpretability to ensure reliability in safety-critical simulations. Ongoing research focuses on self-supervised frameworks to alleviate dependencies, paving the way for broader adoption.

Mesh Enhancement

High-Order Elements

High-order elements in mesh generation utilize polynomial basis functions of degree greater than one to represent both the solution and the geometry within each element, enabling more accurate approximations of curved domains compared to linear elements. Examples include quadratic tetrahedra or higher-degree hexahedra, where the element interiors and boundaries are defined by smooth, curved surfaces rather than straight facets. This approach is particularly valuable for capturing complex geometries in simulations requiring high fidelity, such as those involving fluid-structure interactions or wave propagation. The core of high-order elements lies in isoparametric mapping, which employs the same functions for the physical coordinates and the field variables. Shape functions are typically higher-order Lagrange polynomials N_i(\xi), defined on a reference element parameterized by \xi \in [-1, 1]^d, where d is the spatial dimension. The of the physical element is then obtained via \mathbf{x}(\xi) = \sum_i N_i(\xi) \mathbf{x}_i, with \mathbf{x}_i denoting the nodal coordinates, ensuring that the mapped element conforms exactly to the curved boundaries at the nodes. This mapping preserves the polynomial degree for both and solution, facilitating seamless integration in numerical solvers. Generation of high-order meshes often starts from a low-order straight-edged , which is then curved through of additional nodes on edges, faces, and interiors to match the underlying CAD . Techniques such as transfinite or optimization-based deformation, treating the mesh as an body, ensure validity and quality by minimizing distortion while fitting boundaries. In the context of hp-finite element methods (hp-FEM), spectral elements employ high-order polynomials (typically degree 5–15) with Gauss-Lobatto-Legendre nodal points, allowing for exponential convergence in smooth regions and efficient handling of multi-scale problems. These methods are integrated with adaptive p-refinement to selectively increase polynomial order in regions of interest. High-order elements find prominent applications in high-fidelity (CFD), where they enable precise resolution of turbulent flows and shock structures with significantly fewer than low-order methods—often requiring 5–10 times fewer elements for comparable accuracy in smooth flows. NASA-sponsored workshops on high-order CFD methods, such as the CFD Verification Workshops, routinely employ these elements for cases like hypersonic flows over reentry vehicles, demonstrating their role in advancing simulations by balancing accuracy and computational cost. Recent advancements as of 2025 include scalable mesh generation with refinement patterns via high-order finite elements and fully coupled block-structured approaches for fluid-structure interaction simulations.

Mesh Improvement

Mesh improvement encompasses a range of post-processing techniques applied to existing meshes to enhance their geometric quality and ensure validity, particularly by addressing issues like poor element shapes, high ratios, and inverted (negative ) elements that can compromise numerical solvers. These methods operate on the and node positions of the mesh without altering the overall domain representation, focusing on local modifications to achieve global improvements in metrics such as element angles and stretches. Such enhancements are crucial for ensuring and accuracy in finite analysis, where poor initial meshes from automated generators often require refinement. Key methods include , untangling, and . repositions to improve element shapes, with Laplacian smoothing being a foundational approach that moves each interior to the of its neighbors, iteratively reducing irregularities while preserving . This technique, effective for eliminating obtuse angles, has been widely adopted since the late for both surface and meshes. Untangling addresses inverted elements by optimizing positions to restore positive Jacobians, often using inverse mapping strategies that minimize distortions in the isoparametric , ensuring all elements map validly from reference to physical space. , meanwhile, modifies through edge or face to resolve poor ; in , this involves flipping edges to satisfy criteria like the empty property, while in , face swaps reconfigure tetrahedral to avoid sliver elements. Algorithms like those combining edge flipping in exemplify topology-based optimization to minimize maximum angles or stretches. These techniques are typically applied in iterative procedures, alternating local operations (e.g., node-by-node or targeted flips) with global passes to propagate improvements across the . Convergence is assessed using quality thresholds on metrics such as the minimum or scaled , halting iterations when no further enhancements exceed a predefined tolerance, often after 10-50 passes depending on initial mesh degradation. In applications, mesh improvement is essential for fixing inverted in 3D unstructured meshes, a common issue in complex geometries, enabling robust solvers in and ; advancements in the 1990s and 2000s, including integrated swapping- frameworks, significantly improved reliability for large-scale simulations. Recent techniques as of 2025, such as element shape transformation for polyhedral mesh untangling and graph neural network-based for , offer enhanced efficiency for complex and curvilinear es. These methods complement high-order element representations by first ensuring linear mesh validity.

Applications and Research Landscape

Mesh Types by Use

In computational fluid dynamics (CFD), structured meshes with refined boundary layers are commonly employed to capture turbulent flows accurately, as they provide high resolution near walls where velocity gradients are steep. Hybrid meshes, combining structured prisms near boundaries with unstructured tetrahedra in the far field, are preferred for multi-physics simulations involving fluid-structure interactions, enabling efficient handling of complex geometries while maintaining accuracy in turbulent regions. For electromagnetics applications, conformal tetrahedral meshes are essential for solving , as they ensure alignment with curved surfaces to minimize discretization errors in wave propagation and problems. Recent advancements in 2025 have introduced robust mesh repair techniques that address geometric faults, such as gaps or overlaps in CAD models, through node alignment and boolean operations, improving simulation reliability for high-frequency electromagnetic devices. In , image-based anisotropic meshes derived from medical scans like MRI or are used to model soft s, incorporating directionally varying element sizes to reflect the heterogeneous and orthotropic properties of materials such as or muscle. High-order isogeometric meshes using NURBS-based elements enable accurate modeling of interfaces in simulations, achieving reduced computational cost and improved strain predictions compared to linear elements. Other domains leverage specialized mesh types for their unique demands; in automotive crash simulations, hexahedral-dominant meshes prevail due to their superior handling of large deformations and interactions, providing stable element shapes during impact analysis. In geophysics, adaptive meshes refine resolution around fault zones to simulate ruptures, allowing dynamic adjustment to capture wave propagation and slip dynamics in heterogeneous subsurface models. Emerging trends in 2025 emphasize multiblock structured meshes for CFD in complex organic domains, such as paleobiological around amphibian shapes, where the domain is partitioned into simpler blocks to enhance parallelism and accuracy while accommodating irregular boundaries.

Key Developments and Challenges

Mesh generation has evolved significantly since its origins in the (FEM) during the 1960s, when foundational work at institutions like the , introduced piecewise polynomial approximations for , marking the birth of automated techniques for complex geometries. By the , advances in unstructured mesh generation enabled more flexible handling of irregular domains, with methods like advancing front and improving automation and quality for and beyond. A notable recent milestone is the 2025 SIAM International Meshing Roundtable, which featured innovations in quadrilateral mesh generation for open surfaces with negative Euler characteristics, addressing topological challenges in surfaces with multiple boundaries using symmetric Abel differentials. Contemporary developments emphasize scalability and integration of advanced techniques. Researchers at the introduced a topology-based framework in 2025 for scalable high-order mesh generation, incorporating refinement patterns and high-order basis functions to support efficient simulations on large-scale geometries. Additionally, autoregressive models for next-level-of-detail (LOD) prediction have emerged, enabling progressive refinement from coarse to fine structures in a controlled, sequential manner, as demonstrated in recent preprints. Key challenges persist in parallel mesh generation for , where generating and partitioning meshes with billions of elements demands efficient topological consistency across distributed systems to avoid bottlenecks in high-performance simulations. Handling multiphysics interfaces also remains difficult, requiring meshes that conform to disparate length scales and material boundaries without introducing numerical artifacts in coupled simulations like fluid-structure interactions. Existing resources, such as entries on mesh generation, underemphasize emerging issues like AI-driven scalability and practices, as highlighted in presentations at the 2025 AICOMAS conference on energy-efficient algorithms for near-optimal unstructured meshes. Looking ahead, mesh generation is poised for deeper integration with digital twins, where automated meshing frameworks support real-time updates from sensor data in additive manufacturing and industrial simulations. Fault-tolerant approaches for electromagnetics, including node alignment and boolean operations to repair geometric defects, promise more robust meshes for high-fidelity electromagnetic modeling. Adaptive methods can partially mitigate these challenges by dynamically refining interfaces, though broader scalable solutions are needed.

Research Community

The research community in mesh generation includes influential practitioners and institutions driving advancements in computational modeling. Joseph E. Flaherty has been a key figure in adaptive mesh generation, particularly through his contributions to numerical methods for partial differential equations, as detailed in his co-edited volume on modeling, mesh generation, and adaptive techniques. Leading institutions such as conduct extensive research on automated volume mesh generation for , developing tools to handle complex geometries and adaptive refinement. Similarly, maintains the toolkit, a robust platform for generating two- and three-dimensional finite element meshes used in engineering simulations. Core publications shaping the field include the International Journal for Numerical Methods in Engineering, established in 1969 to disseminate pioneering finite element and numerical techniques. The Journal of Computational Physics frequently features innovations in unstructured and adaptive algorithms for physics-based simulations. Likewise, the SIAM Journal on Scientific Computing hosts high-impact papers on algebraic quality metrics and optimal methods. Major conferences foster collaboration and knowledge exchange. The SIAM International Meshing Roundtable, initiated in 1992 by , has evolved into an annual event convening experts on mesh generation challenges and solutions; the 2025 workshop occurred in . The European Community on Computational Methods in Applied Sciences (ECCOMAS) congresses include dedicated sessions on mesh generation for applied simulations. Specialized workshops, such as NASA's CFD High-Lift Prediction Workshops, emphasize high-order mesh generation and validation for aerodynamic applications. The 2025 joint DTE AICOMAS highlighted emerging topics like green approaches for near-optimal mesh generation. Recent trends underscore a transition to open-source paradigms, with tools like —initiated in the late as a three-dimensional finite element mesh generator—enabling widespread accessibility and customization under the GNU General Public License. Community collaboration is bolstered by organizations such as NumFOCUS, which sustains open-source projects like FEniCS that integrate mesh generation for finite element analysis in scientific computing.

References

  1. [1]
    What is a Mesh? | SimWiki Documentation - SimScale
    Feb 17, 2023 · Meshing is the method of generating a 2D or 3D grid over a geometry in order to discretize it and analyze it with simulation. The grids are ...<|control11|><|separator|>
  2. [2]
    What is Meshing? |Mesh Generation Overview - Cadence
    Meshing or mesh generation discretizes a geometry surface or volume into multiple elements. Learn about high-order mesh generation using Fidelity Pointwise.
  3. [3]
    What Is Meshing: Unlocking the Power of 3D Geometry
    Meshing is a fundamental process in engineering that involves discretizing a spatial domain into a set of discrete elements or cells.
  4. [4]
    None
    ### Summary of Fundamentals of Mesh Generation in Finite Element Analysis
  5. [5]
    (PDF) Mesh Generation in CFD - ResearchGate
    A preprocessing step for the computational field simulation is the discretization of the domain of interest and is called mesh generation.Abstract · References (68) · Recommended Publications
  6. [6]
    [PDF] Numerical Grid Generation Techniques
    The material in this document has been presented at the workshop on Numerical Grid Generation Techniques held at NASA Langley Research. Center October 6-7, 1980 ...
  7. [7]
    Eighty Years of the Finite Element Method: Birth, Evolution, and Future
    Jun 13, 2022 · This document presents comprehensive historical accounts on the developments of finite element methods (FEM) since 1941, with a specific ...
  8. [8]
    A code for numerical generation of boundary-fitted curvilinear ...
    J.F. Thompson et al. Boundary-Fitted Curvilinear Coordinate System for Solution of Partial Differential Equations on Fields Containing Any Number of Arbitrary ...
  9. [9]
    The Importance of Meshing in CFD and Structural FEA
    Meshing for CFD and FEA facilitates accurate simulation of flow or other physical phenomena. Meshing discretizes a complex object into well-defined cells ...
  10. [10]
    Robust mesh generation for electromagnetic models with geometric ...
    Jul 2, 2025 · The aligned surface mesh can also play an important role in watertightness repair and Boolean algorithms, which will also be discussed later.
  11. [11]
    CFD mesh generation for biological flows: Geometry reconstruction ...
    As a cost-effective and powerful method, Computational Fluid Dynamics (CFD) plays an important role in numerically solving environmental fluid mechanics.Missing: electromagnetics | Show results with:electromagnetics
  12. [12]
    Challenges in unstructured mesh generation for practical and ...
    Oct 1, 2013 · However, it usually takes time to create large unstructured meshes. This becomes a critical issue when many meshes are needed in a process, ...
  13. [13]
    [PDF] Mesh Generation 1 Introduction
    Solid modeling and mesh generation are currently separate steps, per- formed by software from di erent sources, but we expect greater integration in the future.<|control11|><|separator|>
  14. [14]
    Different Types of Meshes in CFD | GridPro
    Discover the different types of meshes in Computational Fluid Dynamics (CFD), including structured, unstructured, hybrid, and polyhedral meshes.
  15. [15]
    [PDF] ALGEBRAIC MESH QUALITY METRICS 1. Introduction ... - OSTI.GOV
    A metric on a fixed element type is versatile if it is sensitive to more than one distortion mode (e.g., skew and aspect ratio), otherwise it is specialized.Missing: orthogonality | Show results with:orthogonality
  16. [16]
    [PDF] What is a good mesh? - Wolf Dynamics
    Hereafter, we will present the most common mesh quality metrics: •. Orthogonality. •. Skewness. •. Aspect Ratio. •. Smoothness.
  17. [17]
    [PDF] Variational Generation of Prismatic Boundary-Layer Meshes for ...
    Boundary-layer meshes are important for numerical simulations in computational fluid dynamics, including computational biofluid.
  18. [18]
    [PDF] Introduction - Purdue Computer Science
    An excellent source for many aspects of mesh generation not covered by this book is the Handbook of Grid Generation [216], which includes many chapters on ...
  19. [19]
    [PDF] An introduction to Mesh Generation
    Figure 1.4: Computation of Euler's characteristic χ for different manifold meshes. ... FINITE ELEMENT MESH GENERATION IN THE PLANE. We have ˆw(ξ,η) = w(x(ξ), y(η)) ...
  20. [20]
    [PDF] Generation of Generalized Meshes by Extrusion from Surface ...
    The generalized mesh topology places no restriction on the number of edges used to define a face or the number of faces used to define a cell. The advantage ...
  21. [21]
    [PDF] Topology-Adaptive Mesh Deformation for Surface ... - Hal-Inria
    In this paper, we address the problem of how to maintain the manifold properties of a surface while it undergoes strong deformations that may cause topological ...
  22. [22]
    [PDF] Finite element methods in scientific computing
    finite element method. Part 3: Piecewise polynomial approximation in 2d/3d ... In 3d: Cells can be tetrahedra, hexahedra, pyramids, prisms. ○. The ...
  23. [23]
    [PDF] Volume of a Tetrahedron - People @EECS
    Apr 3, 2012 · The replacing row j in B by r'B yields a new matrix B with det(B) = ß·det(B) , and easier to compute accurately after preconditioning by ...
  24. [24]
    [PDF] Mesh Generation for Implicit Geometries Per-Olof Persson
    To illustrate higher dimensional mesh generation, we create a simplex mesh of the unit ball in 4-D. The nodes now have four coordinates and each simplex element ...
  25. [25]
    Higher-Dimensional Simplexes - Brown Math
    The n-simplex is the smallest figure that contains n + 1 given points in n-dimensional space and that does not lie in a space of lower dimension.Missing: mesh | Show results with:mesh
  26. [26]
    [PDF] Three Dimensional Boundary Conforming Delaunay Mesh Generation
    This work studies unstructured mesh generation problems in three dimen- sions with an emphasis on its application in the computer simulation of physical and ...<|control11|><|separator|>
  27. [27]
    [PDF] arXiv:2207.03921v1 [math.NA] 8 Jul 2022
    Jul 8, 2022 · The graph Tadj can be understood as the dual graph of the finite element mesh, and its vertices are therefore given by the elements. We ...
  28. [28]
    A unified framework of multi-objective cost functions for partitioning ...
    The resulting graph that arises from using the first neighbor-ship criterion is called a dual graph of the finite element mesh, whereas a graph associated with ...
  29. [29]
    Recent progress in robust and quality Delaunay mesh generation
    The dual Delaunay triangulation is called the centroidal Voronoi–Delaunay triangulation (CVDT) which often yields high-quality Delaunay meshes [20], [26], [32].<|control11|><|separator|>
  30. [30]
    [PDF] Hexagonal Mesh - Institute of Geometry - TU Graz
    Sep 18, 2007 · Given a regular triangle mesh T approximating surface S. Dupin dual of T is the hex mesh formed by connecting Dupin centers of all adjacent.
  31. [31]
    [PDF] Flow Visualization Research @ IDAV
    Lagrangian Flow Visualization ... Lagrangian Flow Visualization. 3D Visualization: DVR of FTLE fields using a 2D transfer function ... handling + dual mesh. Page 50 ...
  32. [32]
    Duality Techniques for Error Estimation and Mesh Adaptation in ...
    We present a general method for error control and mesh adaptivity in Galerkin finite element discretization of variational problems governed by differential ...
  33. [33]
    [PDF] Introduction - People @EECS
    Formally, a mesh must be a complex, defined in Section 1.5. The mesh generation problem becomes superficially easier if we permit what finite element ...
  34. [34]
    [PDF] Introduction to Finite Element Methods
    For quasi-uniform grids, define the mesh size of T as hT := maxτ∈T hτ . It is used to measure the approximation rate. In FEM literature, we often write a ...
  35. [35]
    [PDF] Conforming and Nonconforming Finite Element Methods for ... - arXiv
    Jun 14, 2021 · 2.2.1 Conforming FEMs. Two examples of conforming finite elements, namely the Argyris triangle and Bogner-Fox-Schmit rectangle, are presented ...<|separator|>
  36. [36]
    [PDF] MESH SIZE FUNCTIONS FOR IMPLICIT GEOMETRIES AND PDE ...
    The element sizes can be described by a mesh size function h(x) which is determined by many factors. At curved boundaries, h(x) should be small to resolve the ...
  37. [37]
    [PDF] Finite Element Methods for PDEs - People
    Feb 4, 2021 · Definition 11.2.4 (shape regularity of mesh sequence (Mh)h). A sequence of meshes (Mh)h is shape regular if there exists a constant σ such ...
  38. [38]
  39. [39]
  40. [40]
    [PDF] Transfinite Mappings and their Application to Grid Generation - DTIC
    Joe F. Thompson, editor. 171. TRANSFINITE MAPPINGS AND THEIR APPLICATION TO GRID GENERATION. WILLIAM J. GORDON AND LINDA C. THIEL. Department of Mathematical ...Missing: seminal | Show results with:seminal
  41. [41]
  42. [42]
  43. [43]
    [PDF] UC Davis - eScholarship
    Jun 15, 2025 · The earliest form of structured grid generation in CFD involved algebraic techniques, or transfinite interpolation (TFI), where the mesh ...
  44. [44]
    Numerical solution of the quasilinear poisson equation in a ...
    A finite-difference method using a nonuniform triangle mesh is described for the numerical solution of the nonlinear two-dimensional Poisson equation.
  45. [45]
    A comparative numerical study of meshing functionals for variational ...
    Mar 16, 2015 · Abstract:We present a comparative numerical study for three functionals used for variational mesh adaptation.Missing: generation seminal
  46. [46]
    [PDF] High-order unstructured curved mesh generation using the Winslow ...
    Mar 10, 2016 · Abstract. We propose a method to generate high-order unstructured curved meshes using the classical Winslow equations.
  47. [47]
    [PDF] Delaunay Refinement for 2D Mesh Generation
    A quite di erent tech- nique for quality mesh generation is Delaunay re nement, so-called because a Delaunay triangulation is maintained, and some criterion is ...
  48. [48]
    Generation of three-dimensional unstructured grids by ... - AIAA ARC
    Jan 11, 2025 · The advancing-front method generates 3D grids by defining surfaces, using a background grid, and deleting faces from the front to generate ...
  49. [49]
    [PDF] Lecture Notes on Delaunay Mesh Generation - People @EECS
    Feb 5, 2012 · The simplest topological transformation is the edge flip in a triangular mesh, which replaces two triangles with two different triangles.<|control11|><|separator|>
  50. [50]
    Application of CFD to environmental flows - ScienceDirect.com
    For meshing, we propose an approach based on unstructured meshes that enables CFD practitioners to economically model complex geometries and complex flow ...
  51. [51]
    [PDF] manual.pdf - TetGen
    Abstract. TetGen is a program to generate tetrahedral meshes from 3d poly- hedral domains. Its goal is to generate good quality tetrahedral meshes.Missing: unstructured | Show results with:unstructured
  52. [52]
    Regular Article: Elliptic Grid Generation Based on Laplace Equations
    An elliptic grid generation method is presented to generate boundary conforming grids in domains in 2D and 3D physical space and on minimal surfaces.Missing: mesh | Show results with:mesh
  53. [53]
    [PDF] A Multigrid Method for Elliptic Grid Generation Using Finite Volume ...
    The second order finite difference scheme was used for the discretization of the grid generating equations. The linear system is solved by the ADI method.
  54. [54]
    A Variational Form of the Winslow Grid Generator - ScienceDirect.com
    Abstract. A structured grid generator based on a new approximation of Dirichlet's functional is developed. An unconstrained minimization process guarantees that ...Missing: paper | Show results with:paper
  55. [55]
    On 2D structured mesh generation by using mappings
    Jul 25, 2011 · 2 A. M. Winslow, Numerical solution of the quasi-linear Poisson equation in a nonuniform triangle mesh, J Comput Phys 1 ( 1966), 149–172.
  56. [56]
    None
    ### Summary of Hyperbolic Grid Generation from NASA Document (19810006209)
  57. [57]
    [PDF] GRIDGEN'S IMPLEMENTATION OF PARTIAL DIFFERENTIAL ...
    The use of hyperbolic PDEs for structured grid generation began in 1980[11]. While many researchers have contrib- uted to the advancement of hyperbolic methods, ...Missing: seminal | Show results with:seminal
  58. [58]
    [PDF] Generation of Three-Dimensional Body-Fitted Grids by Solving ...
    Hyperbolic grid generation procedures are described which have been used in external flow simula- tions about complex configurations.
  59. [59]
    Use of Advanced CFD Codes in the Turbomachinery Design Process
    The 2D and 3D grid-generation method, used mainly for time-marching methods, is based on the code GRAPE of Sorenson. (1980), which involves the solution of the ...
  60. [60]
  61. [61]
    [PDF] Numerical Grid Generation for Parabolic Partial Differential ... - DTIC
    This study develops a new technique for generating flow field grids around arbi- trarv configurations such as transatmospheric vehicles, missiles, ...
  62. [62]
    A simple error estimator and adaptive procedure for practical ...
    Craig, J. Z., Zhu and O. C. Zienkiewicz, ' A posteriori error estimation, adaptive mesh refinement and multi-grid methods using hierarchical finite element ...Missing: original | Show results with:original
  63. [63]
    A posteriori error estimation in finite element analysis - ScienceDirect
    This monograph presents a summary account of the subject of a posteriori error estimation for finite element approximations of problems in mechanics.
  64. [64]
    Goal-oriented error estimation and adaptivity for the finite element ...
    In this paper, we study a new approach in a posteriori error estimation, in which the numerical error of finite element approximations is estimated in terms ...
  65. [65]
    Mesh adaptation -- CFD-Wiki, the free CFD reference - CFD Online
    May 17, 2012 · Mesh adaptation strategies can usually be classified as one of three general types: r-refinement, h-refinement, or p-refinement. Combinations of ...
  66. [66]
    Adaptive High-Order Methods in Computational Fluid Dynamics
    Aug 6, 2025 · These methods offer the potential to significantly improve solution accuracy and efficiency for vortex dominated turbulent flows. Enough ...
  67. [67]
    [PDF] Adaptive Finite Element Methods
    We shall use Dörfler marking strategy in the proof. After choosing a set of marked elements, we need to carefully design the rule for divid- ing the marked ...
  68. [68]
    [PDF] MULTIGRID SOLUTION STRATEGIES FOR ADAPTIVE MESHING ...
    This paper discusses the issues which arise when combining multigrid strategies with adaptive meshing techniques for solving steady-state problems.
  69. [69]
    Simple and robust h-adaptive shock-capturing method for flux ...
    In this paper, a simple and robust shock-capturing method is developed for the Flux Reconstruction (FR) framework by combining the Adaptive Mesh Refinement ...5. Numerical Results · 5.1. Convergence Study · 5.7. Viscous Shock Tube
  70. [70]
    Adaptive mesh refinement for hyperbolic partial differential equations
    An adaptive method uses multiple component grids, refined based on error estimates, to solve hyperbolic PDEs. It refines in both space and time.
  71. [71]
    Adaptive Mesh Refinement: Algorithms and Applications
    Adaptive mesh refinement (AMR) is a technique we use as a numerical microscope to zoom in on areas of interest in a computer simulation.
  72. [72]
    Generation of computational meshes from MRI and CT-scan data
    We describe here a general purpose method to create com- putational meshes based on the analysis and segmentation of raw medical imaging data. The various.
  73. [73]
    THE GENERATION OF TETRAHEDRAL MESH MODELS FOR ... - NIH
    In this article, we describe a detailed method for automatically generating tetrahedral meshes from 3D images having multiple region labels.
  74. [74]
    [PDF] Mesh Generation for Implicit Geometries Per-Olof Persson
    The method iteratively improves an initial mesh by solving for force equilibrium and projecting boundary nodes using the implicit geometry definition.
  75. [75]
    Marching cubes: A high resolution 3D surface construction algorithm
    Marching cubes creates triangle models of constant density surfaces from 3D medical data using a divide-and-conquer approach and scan-line order.
  76. [76]
    [PDF] A survey of the marching cubes algorithm - CGL @ ETHZ
    The marching cubes algorithm is a cell-by-cell method for extracting isosurfaces from scalar volumetric data, and is a popular isosurfacing algorithm.
  77. [77]
    Scalable point cloud meshing for image-based large-scale 3D ...
    Aug 7, 2019 · This study proposes a scalable point-cloud meshing approach to aid the reconstruction of city-scale scenes with minimal time consumption and memory usage.
  78. [78]
    The generation of tetrahedral mesh models for neuroanatomical MRI
    In this article, we describe a detailed method for automatically generating tetrahedral meshes from 3D images having multiple region labels.
  79. [79]
    [PDF] Image-Based Mesh Generation from 3D data for CAD and CAE
    Jun 25, 2015 · Techniques can be extended to calculating effective material properties using finite-element-based homogenisation.
  80. [80]
    What's the Situation With Intelligent Mesh Generation - IEEE Xplore
    Jun 1, 2023 · Intelligent Mesh Generation (IMG) represents a novel and promising field of research, utilizing machine learning techniques to generate meshes.
  81. [81]
    What's the Situation With Intelligent Mesh Generation: A Survey and ...
    Intelligent Mesh Generation (IMG) represents a novel and promising field of research, utilizing machine learning techniques to generate meshes. Despite its ...
  82. [82]
  83. [83]
    Multi-stage refinement network for point cloud completion based on ...
    Jan 28, 2025 · PointNet++ uses the K-Nearest Neighbors algorithm to sample local neighborhoods by selecting the 'K' nearest points, forming a local region ...
  84. [84]
    Autoregressive Mesh Generation via Next-Level-of-Detail Prediction
    Sep 25, 2025 · Inspired by 2D models that progressively refine images, such as the prevailing next-scale prediction AR models, we propose generating meshes ...
  85. [85]
    High-Fidelity 3D Mesh Generation at Scale with Meshtron
    Dec 13, 2024 · Meshtron provides a simple and scalable, data-driven solution for generating intricate, artist-like meshes of up to 64K faces at 1024-level coordinate ...
  86. [86]
    Graph Neural Networks for Mesh Generation and Adaptation in ...
    In this paper, we introduce Adaptnet, a Graph Neural Networks (GNNs) framework for learning mesh generation and adaptation.
  87. [87]
    Graph Neural Network-Based Topology Optimization for Self ... - arXiv
    Aug 26, 2025 · This paper presents a machine learning-based framework for topology optimization of self-supporting structures, specifically tailored for ...
  88. [88]
    Green AI for Near-Optimal Mesh Generation - DTE AICOMAS 2025
    This talk will cover our recent work on using artificial intelligence to predict near-optimal meshes suitable for simulations. The main idea is to take ...
  89. [89]
    Generating Near-Optimal Meshes Using Green AI | Request PDF
    This work presents a novel approach capable of predicting an appropriate spacing function that can be used to generate a near-optimal mesh suitable for ...
  90. [90]
    MeshGAN: Non-linear 3D Morphable Models of Faces - ar5iv - arXiv
    In this paper, we propose the first intrinsic GANs architecture operating directly on 3D meshes (named as MeshGAN). Both quantitative and qualitative results ...Missing: integration | Show results with:integration
  91. [91]
    MeshKINN: : A self-supervised mesh generation model based on ...
    May 8, 2025 · A novel self-supervised learning framework is proposed for mesh generation. · This scheme can generate high-quality meshes without any datasets ...
  92. [92]
    A New Mesh Generation Method Based on Deep Learning
    Aug 7, 2025 · We introduce a novel approach to automatic unstructured mesh generation using machine learning to predict an optimal finite element mesh for a previously ...
  93. [93]
    Mesh Order Explained: Understanding High-Order Mesh Generation
    A high-order mesh connects adjacent mesh points with a curve of polynomial degree higher than one (i.e. linear). The easiest way to understand high-order ...
  94. [94]
    [PDF] Curved Mesh Generation and Mesh Refinement using Lagrangian ...
    We propose a method for generating well-shaped curved unstructured meshes using a nonlinear elasticity analogy. The geometry of the domain to be meshed is ...
  95. [95]
    Modeling Arbitrary-order Lagrange Finite Elements in ... - Kitware, Inc.
    Aug 27, 2018 · This technique enhances existing cells, so they can fit a higher-order polynomial to the simulation solution. As a result, the cells can ...
  96. [96]
    [PDF] The Generation of Valid Curvilinear Meshes
    Simple techniques for obtaining high-order boundary nodes include interpolating them between the first-order boundary nodes in the parametriza- tion describing ...
  97. [97]
    Spectral/hp element methods: Recent developments, applications ...
    Apr 11, 2018 · This paper briefly describes the formulation of the spectral/hp element method and provides an overview of its application to computational fluid dynamics.
  98. [98]
    High Fidelity CFD Workshop 2022 - Turbulence Modeling Resource
    This workshop, focused on exploring high-fidelity CFD methodologies, is made up of 5 different test suites.
  99. [99]
    [PDF] High-Order CFD Methods: Current Status and Perspective
    High-order CFD methods, defined as third order or higher, aim for higher accuracy with lower cost, and are needed for accurate resolution of unsteady vortices.
  100. [100]
    [PDF] Tetrahedral Mesh Improvement Using Swapping and Smoothing
    In this article we compared combinations of mesh swapping and mesh smoothing techniques used to improve the quality of tetrahedral meshes. Using two random ...Missing: untangling | Show results with:untangling
  101. [101]
    [PDF] ON COMBINING LAPLACIAN AND OPTIMIZATION-BASED MESH ...
    In this article, we propose several techniques that combine the low cost Laplacian smoothing with the optimization-based approach used only for the poorest qual ...Missing: seminal | Show results with:seminal
  102. [102]
    Robust moving mesh algorithms for hybrid stretched meshes
    A robust Mesh-Mover Algorithm (MMA) approach is designed to adapt meshes of moving boundaries problems. A new methodology is developed from the best ...
  103. [103]
    [PDF] CFD and GFD Hybrid Approach for Simulation of Multi-Scale ...
    This paper describes a multi-scale/multi-physics approach for coastal ocean flow prediction, which couples CFD and GFD models using HM and DDM with Chimera.
  104. [104]
    A finite integration method for conformal, structured-grid ...
    We describe a numerical scheme for solving Maxwell's equations in the frequency domain on a conformal, structured, non-orthogonal, multi-block mesh.
  105. [105]
    Image-based biomechanical models of the musculoskeletal system
    Aug 13, 2020 · This paper presents a brief overview of the techniques used for image segmentation, meshing, and assessing the mechanical properties of biological tissues
  106. [106]
    High-order mesoscale modeling with geometrically conforming gray ...
    Sep 22, 2025 · This study demonstrates the unique potential of leveraging IGA to develop mesoscale brain models with conforming tissue boundaries, and is ...
  107. [107]
    [PDF] large deformation for accident vehicle
    Based on the collected typical accident cases of the. 32 vehicle crash, we divide local large deformation into mesh using hexahedral mesh generation. 33.<|separator|>
  108. [108]
  109. [109]
    The crucial role of meshing in computational fluid dynamics ...
    Aug 29, 2025 · A mesh is a computational discretization that divides a continuous domain into finite elements, enabling numerical analysis in various ...2 What Is A Mesh? · 4 Mesh Generation For Cfd · 5.10 Mesh Density And...
  110. [110]
    Unstructured Mesh Generation and Adaptation - ScienceDirect.com
    We first describe the well-established unstructured mesh generation methods as involved in the computational pipeline, from geometry definition to surface ...
  111. [111]
    Quadrilateral Mesh Generation for Open Surfaces with Negative ...
    May 21, 2025 · This study introduces a quadrilateral mesh generation method tailored for surfaces with multiple boundaries and negative Euler characteristic numbers.
  112. [112]
    Scalable Mesh Generation With Refinement Patterns via High-Order ...
    Jan 3, 2025 · The method combines a topology-based framework with a mesh optimization algorithm and uses high-order (curved) elements to construct low-order ( ...<|control11|><|separator|>
  113. [113]
    Parallel exascale mesh generation by subdivision - UBC Library ...
    Jun 24, 2024 · The most challenging part of parallelizing mesh generation software that we addressed in this research work is establishing topological ...
  114. [114]
    [PDF] Multiphysics Simulations: Challenges and Opportunities
    Many diverse multiphysics applications can be reduced, en route to their computational simulation, to a common algebraic coupling paradigm. Mathematical ...
  115. [115]
    A meshing framework for digital twins for extrusion based additive ...
    Sep 15, 2025 · The framework consists of six key steps: tool path generation for AM, tool path parsing and lexing to remove travel paths irrelevant to material ...
  116. [116]
    Monte Carlo multiphysics simulation on adaptive unstructured mesh ...
    Dec 1, 2024 · This paper focuses on methods for multiphysics feedback to unstructured mesh Monte Carlo simulations which are adaptive and flexible.
  117. [117]
    Modeling, Mesh Generation, and Adaptive Numerical Methods for ...
    A mesh-adaptive collocation technique for the simulation of advection-dominated single- and multiphase transport phenomena in porous media.
  118. [118]
    Development of an Automated Volume Mesh Generation CFD ...
    May 30, 2024 · This research project has developed innovative numerical methods aimed at addressing these challenges to enhance the efficiency and feasibility of complex ...
  119. [119]
    CUBIT – Sandia National Laboratories
    Cubit is a full-featured software toolkit for robust generation of two-dimensional and three-dimensional finite element meshes (grids) and geometry preparation.SANDIA REPORT Mesh ...CapabilitiesSANDIA REPORT Sculpt ...Cubit 15.3 User DocumentationCUBIT™ 16.06 User ...
  120. [120]
    OLGIERD C. ZIENKIEWICZ | Memorial Tributes: Volume 16
    ... Journal for Numerical Methods in Engineering, which was first published quarterly in 1969. The journal grew rapidly over the years to its present 48 issues ...
  121. [121]
    Efficient Unstructured Mesh Generation by Means of Delaunay ...
    This work is devoted to the description of an efficient unstructured mesh generation method entirely based on the Delaunay triangulation.
  122. [122]
    Algebraic Mesh Quality Metrics | SIAM Journal on Scientific Computing
    Quality metrics for structured and unstructured mesh generation are placed within an algebraic framework to form a mathematical theory of mesh quality metrics.<|control11|><|separator|>
  123. [123]
    SIAM International Meshing Roundtable Workshop » Home
    In 1992, Sandia National Laboratories started the International Meshing Roundtable as a small meeting of like-minded companies and organizations striving to ...2026 · IMR Award Winners · IMR Steering Committee · Papers ArchiveMissing: history | Show results with:history
  124. [124]
    High-Order Mesh Generation and Mesh Adaptation for Complex ...
    ECCOMAS 2024 · High-Order Mesh Generation and Mesh Adaptation for Complex Geometries with the Open-Source Code NekMesh.
  125. [125]
    [PDF] HLPW-4/GMGW-3: Overview and Workshop Summary
    The purpose of the GMGW series, started in 2017, is to identify, understand, and advance improvements in geometry and mesh-generation technology for CFD in ...<|separator|>
  126. [126]
    Gmsh 4.15.0
    Gmsh is a three-dimensional finite element mesh generator with a build-in CAD engine and post-processor. Its design goal is to provide a fast, light and user- ...