Fact-checked by Grok 2 weeks ago

Polygon mesh

A polygon mesh, also known as a polygonal mesh, is a fundamental in 3D computer graphics and solid modeling consisting of a collection of vertices, edges, and faces that together define the surface geometry of a polyhedral object. These elements form a piecewise linear approximation of a continuous surface, where vertices represent points in 3D space, edges connect pairs of vertices, and faces are typically convex polygons—most commonly triangles for computational efficiency—bounded by edges. Polygon meshes are widely represented using information () alongside positions (), enabling efficient storage and manipulation through data structures such as half-edge or winged-edge representations. Key properties include manifoldness, where each is shared by exactly one or two faces to ensure a surface locally resembling a disk, and orientability, which allows consistent normal directions across faces for applications like and rendering. The , given by V - E + F = 2(1 - g) for a closed orientable surface of g, quantifies topological complexity, with simple spheres having g = 0. In practice, polygon meshes support a range of types, from explicit lists of vertices and faces to indexed formats that reduce redundancy by referencing shared vertices, making them suitable for both manifold and non-manifold geometries. They approximate smooth surfaces with an error proportional to the square of the maximum edge length, allowing refinement through subdivision or remeshing to balance detail and performance. Polygon meshes are essential in numerous domains, including real-time rendering in video games, and reconstruction from laser data, (CAD), finite element analysis (FEA) for simulations, and pipelines for deformation and . Their versatility stems from efficient algorithms for operations like simplification, parameterization, and normal computation, which underpin modern tools and libraries such as and OpenMesh.

Fundamentals

Basic Components

A in a polygon mesh represents a point in , specified by its Cartesian coordinates (x, y, z). These points serve as the foundational elements from which the mesh's is constructed, and vertices often include additional attributes to support rendering and processing, such as vectors for surface orientation, color values for per-vertex shading, or texture coordinates for mapping 2D images onto the surface. An connects exactly two vertices, forming a straight that delineates the boundaries of adjacent faces in the . are fundamental to defining the and , as they outline the shared borders between polygonal regions without carrying independent attributes beyond their endpoint connections. A face constitutes a planar enclosed by a closed of and vertices, most commonly a (three sides) or (four sides) in practical meshes, though polygons with more sides are permitted. Faces are typically convex to simplify rendering and computations, but faces—where at least one interior exceeds 180 degrees—are possible and may introduce complexities in processing. Associated attributes enhance the utility of these components in applications. Surface normals, which indicate the direction perpendicular to the local surface for lighting calculations, can be stored per vertex (interpolated across faces) or per face. Texture coordinates, often denoted as UV pairs (u, v) in a , are usually attached to vertices to enable seamless mapping of textures onto the . Material properties, such as diffuse colors or specular coefficients, may be uniquely assigned to vertices or faces to define appearance variations across the surface. For instance, consider a simple triangular face bounded by vertices \vec{v_1}, \vec{v_2}, and \vec{v_3}, connected by three edges. The face \vec{n}, essential for , is computed via the of two edge vectors and then normalized: \vec{n} = \frac{ (\vec{v_2} - \vec{v_1}) \times (\vec{v_3} - \vec{v_1}) }{ \| (\vec{v_2} - \vec{v_1}) \times (\vec{v_3} - \vec{v_1}) \| } This yields a pointing outward from the face, assuming counterclockwise ordering.

Mesh Properties

Polygon meshes exhibit several key topological properties that determine their structural integrity and suitability for applications in and . refers to whether the mesh surface allows a consistent assignment of normal directions to its faces, distinguishing orientable (two-sided) meshes, where adjacent faces share compatible orientations, from non-orientable (one-sided) ones like strips, which cannot maintain such consistency across the entire surface. The g quantifies the number of "holes" or handles in the surface topology, representing the maximum number of non-intersecting closed curves that can be drawn on the surface without disconnecting it. For a closed, orientable polygonal mesh, these properties relate through the \chi = V - E + F = 2(1 - g), where V is the number of vertices, E the number of edges, and F the number of faces; this formula, originally derived by Leonhard Euler in 1752 for convex polyhedra. Geometric properties further characterize the quality and usability of a polygon mesh, focusing on the spatial arrangement of its elements. Planarity ensures that each face lies in a single , a requirement for efficient rendering and computations in pipelines, as non-planar faces can lead to inaccurate or clipping. Edge lengths influence mesh uniformity, with balanced distributions promoting smoother approximations of curved surfaces, while ratios measure the elongation of faces—ideally close to 1 for equilateral triangles or squares to minimize in simulations and optimizations. High aspect ratios, exceeding 5:1, degrade mesh quality by amplifying numerical errors in finite element analysis. A critical distinction in polygon meshes is between manifold and non-manifold topologies, which affects their robustness in processing and rendering. A manifold mesh requires that every is shared by exactly two faces (closed manifold) or one face ( edges), with vertices exhibiting a consistent of incident faces, ensuring the surface behaves like a without irregularities. Non-manifold meshes violate this, featuring edges adjacent to more than two faces, zero faces (isolated edges), or vertices with disconnected neighborhoods, often arising from modeling errors. Such configurations, including T-junctions where an edge terminates at the interior of another without proper , can produce rendering artifacts like cracks, spurious shadows, or lighting discontinuities due to inconsistent across shared boundaries.

Data Representations

Vertex-Centric Structures

In vertex-vertex meshes, the of a polygon mesh is represented by associating each vertex with a list of its adjacent vertices, forming an undirected where edges imply shared boundaries between faces. This structure is particularly suitable for graph-based algorithms that require efficient traversal of vertex neighborhoods, such as shortest path computations or iterative updates, due to its straightforward access to neighboring vertices. However, it lacks direct access to face information, necessitating additional computations to retrieve incident faces or edges if required. Implementation typically involves storing the adjacency information using either an for dense graphs or, more commonly, an where each points to an or of its neighbors. The of this representation is O(V + E), where V is the number of and E is the number of edges, as each edge contributes two entries in the adjacency lists (one for each ) plus overhead for the lists themselves. This efficiency makes it preferable for sparse meshes common in , where E is roughly $3V for triangular meshes. Such structures find application in algorithms like surface , where Dijkstra's or A* search traverses the to find paths between while respecting mesh . They are also used in basic mesh smoothing techniques, such as Laplacian smoothing, which repositions each toward the of its adjacent to reduce irregularities. For example, in a mesh consisting of 8 and 12 edges, each connects to exactly three adjacent via the edges meeting at that corner, enabling quick neighborhood queries for local operations.

Face-Centric Structures

Face-centric structures, also known as face-vertex meshes, represent a polygon mesh by maintaining a primary list of faces, where each face is defined as an ordered sequence of indices referencing a separate of positions and attributes. This structure treats faces as the central entities, enabling straightforward traversal for rendering operations, as each face directly specifies the connectivity needed to a polygon. For instance, a triangular face might be stored as [v1, v2, v3], where v1, v2, and v3 are indices into the , allowing the to fetch and rasterize the corresponding points efficiently. In terms of storage variants, the data—such as positions, normals, and texture coordinates—can be kept in separate for , or interleaved into a single to optimize access patterns during rendering, particularly on GPUs where coherent layout reduces usage. The face indices are typically stored in a dedicated or , forming an indexed that avoids redundant by reusing shared vertices across multiple faces, which is crucial for GPU-accelerated commands like glDrawElements in . For polygons with more than three vertices (n-gons), the structure supports variable-length face , but rendering often requires on-the-fly , such as using a (connecting all vertices to the first) or (connecting consecutive triplets) to decompose the polygon into triangles compatible with hardware rasterizers. This representation offers key advantages for rendering workflows, providing direct support for rasterization pipelines where faces can be processed independently to generate fragments on the screen. Its space complexity is O(F \times n), where F is the number of faces and n is the average number of vertices per face, making it compact for display-oriented applications while allowing efficient indexing to minimize vertex duplication. Originating in early 1980s graphics hardware, such as Silicon Graphics workstations that relied on polygon lists for real-time rendering of 3D scenes, this structure became a standard in professional graphics systems. A prominent example is the OBJ file format, developed by Wavefront Technologies in the late 1980s, which uses face lists to specify polygons as sequences of vertex indices, facilitating interoperability in 3D modeling and animation pipelines.

Edge-Centric Structures

Edge-centric structures represent polygon meshes by centering the data organization around , which facilitates efficient navigation of topological relationships and boundary traversal. In these representations, each maintains explicit pointers to its incident vertices, adjacent faces, and related edges, enabling constant-time access to neighboring elements. This approach is particularly advantageous for manifold meshes where is important, as it supports operations that require understanding without redundant storage of vertex or face lists. The winged-edge , introduced by Bruce Baumgart in the early , exemplifies this paradigm by associating four "wings" with each edge—two for the left and right faces and their corresponding vertices. Each edge record stores pointers to its two endpoints, the two adjacent faces, and the four half-edges emanating from those vertices in the respective faces, allowing traversal of the topology in O(1) time per neighbor. This structure requires O(E) , where E is the number of edges, making it suitable for algorithms involving edge flipping or local modifications, such as in refinement. Baumgart's design was originally developed for representation in applications. An improvement on the winged-edge model is the half-edge data structure, also known as the (DCEL), which uses directed half-edges to explicitly represent edge orientation and twin relationships. Each half-edge points to its origin , incident face, next and previous half-edges in the face , and its twin half-edge in the opposite direction, providing O(1) access to all adjacent elements while enforcing manifold properties through consistent pairing. Formalized in the late for polyhedra intersection computations, the half-edge structure has become a standard in libraries, such as , where it supports efficient traversal—for instance, following twin half-edges to walk along a mesh without searching the entire structure.

Dynamic and Specialized Representations

Dynamic representations of polygon meshes enable modifications, such as those required in animations or rendering, by supporting efficient updates to positions, , or both without full mesh reconstruction. These structures prioritize runtime adaptability over static storage, often leveraging GPU-accelerated buffers for high-performance rendering. For instance, buffers with dynamic indexing allow GPU updates by mapping CPU-modified data directly to graphics hardware, facilitating seamless deformation in interactive applications. A key technique for rendering dynamic meshes involves vertex skinning, where mesh vertices are influenced by hierarchical bone matrices to simulate articulated motion. Each vertex is assigned weights corresponding to nearby bones, and its final position is computed as a blended linear combination of transformed positions via these matrices, enabling smooth deformations like character limb movements. This method, accelerated on GPUs through shader-based matrix palette skinning, trades increased computational cost per vertex for realistic animation without explicit keyframe interpolation. Subdivision surfaces provide a specialized for approximating smooth surfaces from coarse meshes, particularly useful in dynamic contexts where changes iteratively. By repeatedly refining meshes using rules like Catmull-Clark subdivision, these representations generate surfaces that adapt to deformations while maintaining continuity. Dynamic variants, such as adaptive on GPUs, evaluate subdivisions on-demand to balance detail and performance during . Progressive meshes represent another specialized form, using edge-collapse hierarchies to enable level-of-detail () adjustments. Introduced by Hoppe in , this method constructs a sequence of meshes by reversibly collapsing edges, allowing progressive refinement or coarsening based on viewer distance or resource constraints. The hierarchy stores vertex splits as connectivity records, supporting efficient transmission and rendering of arbitrary triangle meshes with minimal error. Implicit representations, such as signed distance fields (), offer advantages for deformable meshes by encoding as a continuous rather than explicit polygons. An defines the signed distance to the nearest surface point, enabling smooth deformations through field warping without tracking individual faces or edges. For polygon soups—non-manifold meshes common in simulations— facilitate and morphing, converting discrete meshes to volumetric data for physics-based updates. These were applied to deformable objects in the early , supporting non-penetrating interactions in animations. Vertex clustering exemplifies techniques within dynamic representations, grouping nearby into clusters and replacing them with representatives to reduce count. This method, effective for real-time , reduces the number of faces while preserving overall shape, though it may introduce blocky artifacts in fine details. Originating in the early , clustering hierarchies integrate with dynamic updates by allowing selective refinement during runtime. Such representations emerged in the late for , driven by hardware advances enabling real-time and the need for adaptive detail in expansive environments. Dynamic meshes balanced visual fidelity with performance, influencing titles requiring continuous topology changes. Space-time trade-offs in these structures optimize storage and computation: spatial hierarchies reduce per-frame processing, while temporal coherence across animations minimizes redundant updates, though increasing memory for history buffers. For example, space-time schemes exploit frame-to-frame similarities to achieve high-fidelity playback at lower bitrates.

Mesh Processing Techniques

Generation Methods

Polygon meshes can be generated procedurally from simpler geometric and , enabling the creation of complex shapes through algorithmic operations. Common techniques include , where a 2D profile is swept along a to form a surface; , which interpolates between multiple cross-sectional to build transitional surfaces; and revolution, which rotates a around an to produce surfaces of revolution. These methods originated in early () systems and remain foundational in modern tools. Another procedural approach involves , which constructs a mesh by connecting scattered points such that no point lies inside the of any triangle, ensuring optimal element quality. For 2D-to-3D conversion, this triangulation of planar point sets can be extruded or combined with additional layers to form volumetric meshes, particularly useful in terrain modeling or from height fields. Seminal work on Delaunay-based refinement for quality 2D meshes was advanced by Ruppert in 1995, extending earlier triangulation algorithms. Meshes are also generated from volumetric data, such as scans, using extraction algorithms. The algorithm, introduced by Lorensen and Cline in 1987, processes scalar volume data by dividing it into cubes and determining polygon configurations where the intersects cube edges. For each intersecting edge between vertices v_0 and v_1 with scalar values c_0 > \text{isovalue} and c_1 < \text{isovalue}, the intersection point p is computed via : p = v_0 + \frac{\text{isovalue} - c_0}{c_1 - c_0} (v_1 - v_0) This yields a triangulated mesh approximating the isosurface, widely adopted in medical imaging and scientific visualization despite known ambiguities in some configurations. Boolean operations on solid primitives, organized in constructive solid geometry (CSG) trees, provide another generation method by combining shapes through union, intersection, and difference to form complex meshes. CSG representations use hierarchical trees of primitives (e.g., cubes, spheres) and operators, which are then converted to boundary meshes via algorithms that resolve intersections and classify surfaces. This approach, formalized in the 1970s and 1980s, supports precise modeling in CAD and is implemented in libraries like CGAL for polygon mesh output. A specific example of procedural sphere generation is the icosphere, created by starting with a (12 vertices, 20 triangular faces) and iteratively subdividing each triangle into four smaller triangles while projecting new vertices onto a . This method, preferred for uniform triangle distribution in graphics applications, begins with the icosahedron's vertices derived from coordinates and applies subdivision up to the desired resolution, resulting in approximately $20 \times 4^{n} triangles after n iterations. Historically, polygon mesh generation emerged in 1960s CAD research, where systems approximated surfaces using polygonal patches derived from bicubic surfaces, such as Coons patches developed at for design. These early methods laid the groundwork for wireframe and faceted representations in systems like those at , transitioning from manual drafting to computational surface generation.

Modification and Optimization

Modification and optimization of polygon meshes involve algorithms that refine existing meshes to reduce , improve uniformity, or enhance detail while minimizing geometric distortion. These techniques are essential for applications requiring efficient processing, such as rendering or , where high-fidelity meshes must be adapted without excessive loss of shape accuracy. Common approaches include simplification to decrease polygon count, remeshing to achieve more regular , and to eliminate irregularities, often accompanied by cleanup operations to ensure topological validity. Simplification algorithms primarily employ edge collapse and decimation to iteratively remove elements while preserving the overall surface . In edge collapse, pairs of connected by an edge are merged into a single , effectively eliminating the edge and adjacent faces; decimation similarly targets for removal based on local criteria. A widely adopted uses error metrics (QEM) to guide these operations by quantifying the geometric error introduced at each step, minimizing distortion through the error function e = \sum (v - \bar{v})^T Q (v - \bar{v}), where v is the position, \bar{v} is the ideal plane position, and Q is a symmetric 4x4 representing accumulated plane equations from neighboring faces. Remeshing techniques restructure the to produce more uniform elements, such as isotropic triangles of consistent size and , which facilitate subsequent . Isotropic remeshing achieves this by locally parameterizing surface patches and resampling points to form equilateral triangles, often through iterative that balances edge lengths and angles across the surface. Complementary methods, like Laplacian filters, relocate toward the average position of their neighbors, defined as \Delta p_i = \sum_{j \in N(i)} (p_j - p_i), where N(i) denotes the one-ring neighbors of vertex i, iteratively reducing high-frequency while avoiding excessive shrinkage via techniques such as Taubin's λ/μ method. For real-time optimization, GPU-accelerated methods in the 2020s leverage to perform simplifications efficiently, achieving polygon reductions of up to 99%—such as 70% or more in typical cases—while maintaining low geometric deviation through QEM variants implemented via . An example of optimization for higher detail is the Catmull-Clark subdivision scheme, which refines coarse meshes by averaging positions across faces, edges, and vertices in iterative passes to generate smoother, higher-resolution surfaces approximating the limit shape. During these modifications, handling non-manifold elements—such as vertices with inconsistent connectivity—is crucial to prevent topological errors; algorithms like repair such defects by probabilistically retriangulating affected regions to enforce manifold properties without introducing new artifacts. Recent advances in the mid-2020s have integrated neural networks and into mesh modification and optimization, enabling learning-based techniques for tasks like dynamic updates and feature-preserving repairs. For instance, generative neural fields, such as those in MagicClay, allow sculpting meshes with implicit representations that support topology changes during deformation. Similarly, neural using spherical neural surfaces facilitates direct computation of operators like on manifold meshes without explicit parameterization, improving in optimization pipelines as of 2024-2025.

Analysis and Validation

Analysis and validation of polygon meshes involve computational techniques to assess topological integrity and geometric quality, ensuring the mesh accurately represents the intended surface without defects that could compromise downstream applications. Topological validation focuses on identifying inconsistencies such as self-intersections and non-manifold elements, while evaluates local surface properties and element shapes. These processes are essential for verifying mesh reliability, particularly in fields requiring precise representations like and rendering. Topological validation begins with detecting self-intersections, where mesh elements improperly overlap, violating the in . Common methods include -face tests, which systematically check if any pierces a non-adjacent face by solving for points along the against the of the face and verifying barycentric coordinates within the . For efficiency in large , hierarchies or spatial partitioning can accelerate these tests. Alternatively, from mesh vertices or sample points counts parities with the mesh surface to detect watertightness violations indicative of self-intersections or gaps. Manifold checks ensure the mesh forms a consistent surface without boundaries or singularities, often verified using the formula \chi = V - E + F, where V is the number of vertices, E , and F faces; for a closed orientable , \chi = 2 - 2g, allowing detection of handles or non-manifold regions if the value deviates unexpectedly. Geometric analysis quantifies local surface behavior and element quality to identify distortions. Curvature estimation approximates continuous surface properties on discrete meshes using operators derived from ; mean curvature H measures average bending, while K indicates intrinsic shape (elliptic, hyperbolic, or parabolic). Discrete versions compute these at vertices via cotangent formulas on the 1-ring neighborhood: for mean curvature normal, \mathbf{H} = \frac{1}{2A} \sum_{j} ( \cot \alpha_j + \cot \beta_j ) ( \mathbf{v}_j - \mathbf{v}_i ), where A is the Voronoi cell area, and angles \alpha_j, \beta_j are opposite the edge to neighbor j; follows K = \frac{1}{A} \sum_j \theta_j - 2\pi for the angle defect. Quality metrics for triangular elements include the , defined as the ratio of the longest to shortest edge, with ideal values below 5:1 for near-equilateral shapes to minimize errors in simulations. Practical tools facilitate these analyses; , an open-source system developed in the mid-2000s, provides filters for topological repair checks, self-intersection detection, and curvature visualization on large unstructured meshes. Recent advancements in the incorporate AI for , such as Bayesian filtering on 3D meshes to identify surface defects by modeling probabilistic deviations from nominal geometry. For instance, holes—open boundaries indicating incomplete surfaces—are detected by identifying boundary loops through traversal of unpaired edges, starting from any edge with only one adjacent face and following the chain until closure, enabling diagnosis of topological gaps without alteration.

Applications

Computer Graphics and Rendering

Polygon meshes serve as the primary geometric representation in rendering pipelines, enabling the transformation of models into 2D images through rasterization or ray tracing. In the rasterization process, meshes are projected onto the screen, where polygons are filled and shaded to produce visual output. This integration allows for efficient handling of complex scenes in applications like and offline rendering in . Historically, the shift from wireframe displays to shaded polygon meshes occurred in the mid-1970s, driven by advancements in hardware that supported filled polygons and basic shading models, marking a pivotal evolution in visual realism. Key rendering optimizations for polygon meshes include backface culling, which eliminates polygons oriented away from the camera to reduce processing overhead by approximately 50% in closed models, and hardware , which dynamically subdivides low-detail meshes into finer triangles during the shader pipeline to enhance surface detail without storing high-polygon in memory. Tessellation shaders, introduced in modern GPUs, generate variable-density triangles based on screen-space criteria, allowing adaptive refinement for curved surfaces or effects. These techniques ensure balanced performance and quality, particularly in environments where draw calls must be minimized. For advanced rendering, polygon meshes integrate seamlessly with ray tracing by computing intersections between rays and triangle primitives, a process accelerated by algorithms like the Möller-Trumbore method, which efficiently determines hits using vector operations without precomputing plane equations. This enables realistic effects such as shadows, reflections, and in mesh-based scenes. Level-of-detail (LOD) management further optimizes performance by swapping higher-polygon meshes for simplified versions as objects recede from the viewer, maintaining frame rates in large-scale virtual worlds. Additionally, applies texture-based perturbations to low-poly meshes, simulating fine geometric details like through altered surface normals, thus preserving efficiency while approximating high-fidelity appearances. In practice, polygon meshes have been central to landmark productions, such as Pixar's 1986 short film Luxo Jr., rendered using the Reyes architecture in RenderMan, which dices polygonal geometry into micropolygons for high-quality shading and . More recently, 5's Nanite system, released in 2021, virtualizes polygon meshes to render scenes with billions of triangles at interactive rates, eliminating traditional authoring by streaming only visible micropolygons to the GPU. These innovations underscore the enduring role of polygon meshes in bridging artistic modeling with performant, photorealistic display.

Engineering and Simulation

In (CAD), polygon meshes serve as approximations of (B-rep) models for , where precise geometric boundaries defined by points, curves, and surfaces are tessellated into triangular or polygonal facets to facilitate , , and processes. This approach enables the representation of complex 3D volumes without requiring exact surfaces, particularly useful in convergent modeling workflows that integrate meshes with B-rep for engineering design. Polygon meshes are integral to finite element meshing in CAD for stress analysis, where CAD geometry is discretized into polygonal finite elements to simulate structural responses under various loads, allowing engineers to predict deformation, strain, and failure points in solid models. For instance, AutoCAD has supported polygon meshes since Release 10 in 1989, enabling early integration of mesh-based surfaces for 3D solid modeling and analysis tasks. In physics-based simulations, polygon meshes underpin through hierarchies (BVHs), such as k-discrete orientation polytopes (k-DOPs), which organize mesh triangles into tree structures for efficient overlap testing between rigid or deformable objects, achieving performance in scenarios like virtual prototyping. Tetrahedral meshes, a volumetric extension of triangular polygon meshes, are widely used in simulations to discretize domains around irregular boundaries, enabling adaptive resolution that focuses computational effort on high-gradient regions like or free surfaces while conserving mass and momentum. Advancements in the 2020s have leveraged on to redesign engineering components, achieving material reductions of up to 30% while maintaining structural integrity, as demonstrated in optimized castings for . A representative example is deformation under load using mass-spring systems, where vertices act as masses connected by springs to model responses, dynamically updating via shape matching to preserve and avoid super- artifacts in simulations.

Scientific and Medical Visualization

In medical visualization, polygon meshes play a crucial role in from volumetric data such as MRI and scans, where segmented regions are converted into meshes to enable detailed anatomical modeling and therapeutic planning. For instance, deep learning-based pipelines can reconstruct cortical surfaces from 1-mm isotropic T1-weighted MRI images in under 5 minutes, producing high-fidelity meshes comparable to traditional methods in accuracy. Hybrid approaches combining and MRI further enhance this by generating printable models that enclose surfaces with triangular facets, supporting applications like surgical planning. Volume rendering hybrids integrate polygon meshes with volumetric data to balance transparency and surface detail in , allowing simultaneous visualization of internal structures and external boundaries. These techniques employ ray-tracing through both polygons and volume arrays, sampling at regular intervals to composite semitransparent elements efficiently. A notable historical example is the from the 1990s, which utilized voxel-to-mesh conversion to transform cryosectioned human cadaver data into polygonal representations for anatomical atlases. For watertight medical surfaces, the algorithm excels by decomposing volumes into tetrahedra and extracting isosurfaces, yielding manifold meshes that avoid topological ambiguities inherent in cube-based methods while preserving higher accuracy in curved regions. In scientific visualization, meshes derived from (CFD) simulations delineate flow boundaries and scalar fields, such as velocity or pressure s, to interpret complex phenomena like . These meshes are generated via differentiable extraction from signed distance functions, enabling topology-aware refinements for accurate post-simulation analysis. In molecular modeling, approximations represent biomolecular surfaces, such as solvent-accessible areas, using adaptive meshes that preserve features like crevices and protrusions for electrostatic computations. Tools like TMSmesh facilitate this by partitioning space around atomic centers and radii, producing manifold surfaces suitable for boundary element methods in simulations of large molecules exceeding one million atoms. Recent advances in 2025 incorporate neural rendering techniques, such as Gaussian splatting, to model dynamic organs from multi-modal medical data, generating time-varying polygon meshes that capture deformations in real-time for enhanced procedural visualization. Validation of such meshes ensures scientific accuracy through metrics like , confirming alignment with ground-truth volumes.

Storage Formats

Open Standards

Open standards for polygon mesh storage provide non-proprietary formats that facilitate across software tools, enabling the exchange of without licensing restrictions. These formats serialize mesh data such as vertices, faces, and associated attributes like normals and coordinates into text or structures, prioritizing simplicity and broad adoption in fields like and . Key examples include the , STL, PLY, and formats, each designed with specific use cases in mind while supporting core polygonal representations. The OBJ format, developed by Wavefront Technologies in the late 1980s for its Advanced Visualizer software, is a simple text-based standard that defines 3D surface geometry through polygonal meshes. It supports vertices (positioned with optional weights), faces (polygons referenced by vertex indices), normals (for shading), and UV texture coordinates, allowing for basic material references via companion MTL files. However, OBJ lacks support for hierarchical structures like scene graphs or animations, limiting its use to static geometry exchange. A typical syntax includes lines starting with "v" for vertices and "f" for faces; for instance:
v 0.0 1.0 0.0
f 1 2 3
This represents a at (0,1,0) and a triangular face connecting vertices 1, 2, and 3. The STL (STereoLithography) format, introduced in 1987 by for in processes, exclusively represents meshes as triangulated surfaces suitable for . Available in both ASCII (human-readable text with "facet normal" keywords) and binary variants (compact with an 80-byte header followed by 50-byte facets including normals and three vertices), it focuses solely on surface without color, , or metadata support. Each facet encodes a unit normal vector and vertex coordinates as 32-bit floats, enforcing the for orientation. Precision loss can occur due to its fixed-point representation and lack of scaling factors, often requiring post-processing to repair errors in complex models. Developed in the mid-1990s at Stanford University's Computer Graphics Laboratory, the PLY (Polygon File Format) provides a flexible scheme for storing polygonal models, including support for colored vertices and point clouds beyond strict meshes. Its structure begins with an ASCII header declaring elements (e.g., vertices with x, y, z, red, green, blue properties) and faces (vertex index lists, typically triangles), followed by data in either ASCII or (little- or big-endian) modes for efficient storage. This allows user-defined properties like intensity or reflectivity, making it ideal for scanned data from , while maintaining simplicity for interchange. The (GL Transmission Format), specified by the in the 2010s, serves as a optimized for web and applications, delivering compact 3D scenes with polygon meshes. It uses a file for hierarchical descriptions (nodes, meshes with accessors for positions as VEC3 floats, indices as scalars, normals, and tangents) paired with binary buffers (.bin) for geometry data, or a single GLB binary container. This enables direct GPU loading of attributes and faces, supporting materials and animations, while minimizing file size for real-time rendering.

Proprietary and Specialized Formats

Proprietary formats for polygon meshes are typically developed by software vendors to store complex scene data, including geometry, materials, and animations, within their ecosystems, often with limited public documentation to maintain . These formats contrast with open standards by prioritizing integration with specific tools like or , enabling seamless workflows but complicating interoperability without conversion. The format, owned by , is a widely adopted proprietary binary or ASCII format designed for exchanging 3D assets across applications such as 3ds Max and . It supports polygon meshes through structures like the PolygonVertexIndex array, where vertices and faces are indexed, with negative values denoting the end of each face to optimize storage. is particularly valued in , game development, and animation pipelines for preserving mesh topology, UV coordinates, and skeletal animations during transfers. The format, originating from Autodesk's 3D Studio software, is a legacy format that stores meshes using chunk-based structures, including primary chunks for main objects and secondary chunks for vertices, faces, and coordinates. Each mesh is defined by a list of vertices followed by face indices, supporting up to vertices per object, with basic and smoothing group data. Though outdated due to limitations like no support for n-gons or advanced , it remains in use for importing simple models into modern tools. Autodesk's Maya Binary (.mb) format is a proprietary binary representation for Maya scenes, encapsulating polygon meshes alongside hierarchies, rigs, and effects in a compact, efficient structure that supports 64-bit indices for large models since Maya 2014. Unlike the human-readable Maya ASCII (.ma), .mb files are optimized for faster loading and smaller file sizes, making them standard for production workflows in visual effects and modeling. However, their closed nature requires Maya or compatible exporters for access. Similarly, the .max format serves as the native proprietary binary file for , storing detailed polygon mesh data within full scene descriptions, including modifiers, lights, and particle systems. It enables retention of parametric edits and complex assemblies non-destructively, ideal for architectural and asset creation, but interoperability often necessitates export to formats like . Specialized formats like Pixar's RenderMan Interface Bytestream () are tailored for high-end rendering pipelines, describing meshes via primitives such as PointsPolygons, where separate arrays define positions and face connectivity, optionally including parameters for normals, textures, and subdivision surfaces. Developed for films like , facilitates precise control over mesh rendering in Pixar's ecosystem, though its proprietary aspects limit broader adoption outside licensed RenderMan users. Other specialized formats include Maxon's .c4d for , a binary format that embeds meshes with effectors, tags, and data, suited for broadcast design and product visualization. In contexts, Autodesk's format, while primarily for / CAD, can store approximated meshes derived from solids, supporting mesh entities in later versions for simulation and manufacturing interchange. These formats underscore the trade-offs between specialization and accessibility in polygon mesh storage.

References

  1. [1]
    Polygonal Mesh - an overview | ScienceDirect Topics
    A polygonal mesh refers to a collection of vertices, edges, and faces that form a three-dimensional structure, satisfying certain conditions such as every ...<|control11|><|separator|>
  2. [2]
    [PDF] Mesh Basics
    Jul 6, 2010 · ❑A polygonal mesh consists of three kinds of mesh elements: vertices, edges, and faces. ❑The information describing the mesh elements.Missing: fundamentals | Show results with:fundamentals
  3. [3]
    [PDF] Geometric Modeling Based on Polygonal Meshes - cs.Princeton
    Since polygonal meshes are piecewise linear surfaces, the concepts introduced above cannot be applied directly. The following definitions of discrete ...
  4. [4]
    [PDF] Notes on polygon meshes 1 Basic definitions
    In a graphical application, we will store other information with vertices and faces (colors, normals, texture coordinates, ...), hence the “...” in the code.
  5. [5]
    [PDF] OpenMesh – a generic and efficient polygon mesh data structure
    A polygonal mesh consists of a set of vertices, edges, faces and topological relations between them. Based on these relations, a data structure defines how ...
  6. [6]
    Polygons, Meshes - Paul Bourke
    Test for concave/convex polygon. For a convex polygon all the cross products of adjacent edges will be the same sign, a concave polygon will have a mixture of ...
  7. [7]
    Introduction to Shading (Normals, Vertex Normals and Facing Ratio)
    crossProduct(v2-v0); Figure 2: The face normal of a triangle can be computed from the cross product of two edges of that triangle. If the triangle lies in ...
  8. [8]
    [PDF] Geometry Acquisition and Meshes
    Feb 21, 2018 · ○ A polygonal mesh is orientable, if the incident faces to every ... Global Topology of Meshes. ○ Genus: ½ × the maximal number of closed.Missing: properties | Show results with:properties
  9. [9]
    [PDF] Basic Concepts
    • Polygonal meshes are a good representation. – approximation O(h2) ... Global Topology: Genus. Genus: : Half the maximal number of closed paths that do ...
  10. [10]
    Twenty-one Proofs of Euler's Formula - UC Irvine
    The formula V − E + F = 2 was (re)discovered by Euler; he wrote about it twice in 1750, and in 1752 published the result, with a faulty proof by induction for ...Missing: history | Show results with:history
  11. [11]
    [PDF] Geometric Modeling Based on Polygonal Meshes - CGL @ ETHZ
    The term mesh quality thus refers to non-topological properties, such as sampling density, regularity, size, alignment, and shape of the mesh elements. This ...
  12. [12]
    [PDF] Manifolds, Mesh Representations, and Digital Geometric Processing
    Edge Vertex Split. Goal: Insert edge between vertex v and midpoint of edge e: • Creates a new vertex, new edge, and new face. • Involves much more pointer ...<|control11|><|separator|>
  13. [13]
    [PDF] 10. Polygon meshes - CSE, IIT Delhi
    Page 12. Manifold meshes. A polygon mesh is a manifold only if: • Every edge has exactly 2 adjacent faces. • Every vertex has adjacent faces and edges in a ...<|separator|>
  14. [14]
    Star-Vertices: A Compact Representation for Planar Meshes with ...
    Aug 1, 2025 · Kallmann and Thalmann [KT02] implemented a data structure for representing planar meshes in a compact manner, by means of vertex adjacency.
  15. [15]
    [PDF] Polygonal Meshes - cs.Princeton
    Polygon Mesh Representation. Possible data structures. List of independent faces. Vertex and face tables. Adjacency lists. Winged edge. Half edge.
  16. [16]
    [PDF] Efficient traversal of mesh edges using adjacency primitives
    Figure 1: (a) Our goal is to enable efficient processing of edges in a triangle mesh using adjacency primitives. (b) We select a minimal subset.
  17. [17]
    [PDF] Compromise-free Pathfinding on a Navigation Mesh - IJCAI
    Polygons can overlap but only if they share a common edge or vertex. Two polygons that share an edge are said to be adjacent. Maps and Meshes: A map is a plane ...
  18. [18]
    [PDF] Mesh Smoothing Algorithms Overview j j i 1 v ' v i ni ∈ = jv vi i i i v ...
    • Use Laplacian Operator that fixes boundary shrinkage. • But, how to define the vertex normals ? • Use smooth face normal field instead j i. nijL. nijR t t. C.<|separator|>
  19. [19]
    A simple mesh adjacency data structure
    Jun 25, 2022 · This data structure is an easy to implement solution for traversing a mesh. But if you need to edit the mesh, it usually won't help.
  20. [20]
    Introduction to Polygon Meshes - Scratchapixel
    Polygon meshes or meshes for short are probably the oldest forms of geometry representation used in computer graphics. The idea is simple. It is based on the ...
  21. [21]
  22. [22]
    The OBJ File Format - Scratchapixel
    Primarily, it is used to store and parse mesh geometry, that is, objects made out of polygons. But the OBJ format is quite complex and can support a wide ...
  23. [23]
    Famous Graphics Chips: Geometry Engine - IEEE Computer Society
    Sep 24, 2020 · The Geometry Engine was a special-purpose processor with a four-component vector, floating-point processor for three basic operations in computer graphics.Missing: mesh representation<|separator|>
  24. [24]
    Wavefront OBJ File Format - The Library of Congress
    Feb 20, 2025 · The Wavefront OBJ format defines 3D geometry for object surfaces using polygonal meshes or freeform curves and surfaces. It uses elements like ...<|separator|>
  25. [25]
    [PDF] A polyhedron representation for computer vision
    INTRODUCTION TO THE WINGED EDGE. The Winged Edge polyhedron representation is imple- mented as a data structure composed of small blocks of words containing ...
  26. [26]
    [PDF] Winged Edge Polyhedron Representation - DTIC
    Introduction to Body, Face, Edge, Vertex Modeling. II. Data Structure of Winged Edge Polyhedra. A. Winged Edge Structure. B. Winged Edge Operations. C ...
  27. [27]
  28. [28]
    Implementing vertex buffers - Vulkan Guide
    Our Mesh class will hold a std::vector of Vertex for our vertex data, and an AllocatedBuffer which is where we will store the GPU copy of that data.
  29. [29]
    [PDF] Skinning Mesh Animations - Stanford Computer Graphics Laboratory
    Skinning mesh animations uses matrix palette skinning, estimates proxy bone transforms, and uses nonparametric mean shift clustering to identify bones. It does ...
  30. [30]
    Dynamic Catmull-Clark subdivision surfaces - IEEE Xplore
    We present a new dynamic surface model based on the Catmull-Clark subdivision scheme, a popular technique for modeling complicated objects of arbitrary genus.Missing: polygon | Show results with:polygon
  31. [31]
    Progressive meshes | Proceedings of the 23rd annual conference ...
    This paper introduces the progressive mesh (PM) representation, a new scheme for storing and transmitting arbitrary triangle meshes.
  32. [32]
    [PDF] Signed Distance Fields for Polygon Soup Meshes
    As commonly done in computer graphics, the original non-manifold triangle mesh geometry can then be animated by performing a FEM deformable object simu- lation ...
  33. [33]
    [PDF] Model Simplification Using Vertex-Clustering - NUS Computing
    This paper presents a practical technique to automatically compute approximations of polygonal representations of. 3D objects. It is based on a previously ...Missing: percentage | Show results with:percentage
  34. [34]
    [PDF] Space-Time compression of the 3D animations of triangle meshes ...
    When compressing the animation of a triangle mesh, we distinguish three types of extrapolating predictors: space- only, time-only, and space-time. A space-only ...Missing: offs | Show results with:offs
  35. [35]
    [PDF] A Delaunay Re nement Algorithm for Quality 2-Dimensional Mesh ...
    The technique we use|successive re nement of a Delaunay triangulation|extends a mesh generation technique of Chew by allowing triangles of varying sizes.
  36. [36]
    [PDF] Marching cubes: A high resolution 3D surface construction algorithm
    Abstract. We present a new algorithm, called marching cubes, that creates triangle models of constant density surfaces from 3D medical data.
  37. [37]
    Theory and Implementation
    The required solid object is built from basic solid shapes by applying boolean operations of Union, Intersection or Difference on them. Representation of CSG ...
  38. [38]
    Generating Meshes of a Sphere - Daniel Sieger
    Mar 27, 2021 · A brief tutorial on generating meshes of a sphere, including the UV sphere, icosphere, quad sphere, and Goldberg polyhedra.
  39. [39]
    [PDF] The Engineering Design Revolution CAD History - AWS
    Nearly all my work involved computer graphics including the design and implementation of the first graphics-oriented oil refinery control system. ... 1960s ...
  40. [40]
    Surface simplification using quadric error metrics - ACM Digital Library
    Surface simplification using quadric error metrics. Article. Free access. Share on. Surface simplification using quadric error metrics. Authors: Michael Garland.
  41. [41]
    High-performance simplification of triangular surfaces using a GPU
    In this paper, we present a mesh simplification algorithm that benefits from the parallel framework provided by recent GPUs.
  42. [42]
    [PDF] Recursively generated B-spline surfaces on arbitrary topological ...
    Recursive patch subdivision algorithms have been used extensively in computer graphics since Catmull first devised them for rendering shaded pictures of curved ...
  43. [43]
    [PDF] Repairing Non-Manifold Triangle Meshes using Simulated Annealing
    In this paper we present a new and completely different algorithm for generating manifold tri- angle meshes from incomplete or incorrect triangulations. This ...
  44. [44]
    [PDF] Exact and Robust (Self-)Intersections for Polygonal Meshes
    Abstract. We present a new technique to implement operators that modify the topology of polygonal meshes at intersections and self-intersections.
  45. [45]
    [PDF] Robust Repair of Polygonal Models
    Both methods involve casting rays from each grid point and voting based on the parity or locations of intersections on each ray with the model. However ...Missing: validation | Show results with:validation
  46. [46]
    [PDF] Discrete Differential-Geometry Operators for Triangulated 2-Manifolds
    In this paper we define and derive the first and second order differential attributes (normal vector n, mean curvature κH, Gaussian curvature κG, principal ...
  47. [47]
    The Fundamentals of Mesh Quality in FEA - SDC Verifier
    Mar 18, 2025 · The aspect ratio is a measure of the proportionality of an element's dimensions. For 2D elements, it is typically calculated as the ratio of the ...
  48. [48]
    [PDF] MeshLab: an Open-Source Mesh Processing Tool
    In this pa- per we present MeshLab the 3D mesh processing system that we have developed with the help of many students in the last two years and that fits in ...
  49. [49]
    Surface defect identification using Bayesian filtering on a 3D mesh
    This paper presents a CAD-based approach for automated surface defect detection. We leverage the a-priori knowledge embedded in a CAD model and integrate it ...Surface Defect... · 2. Cad-Based Defect... · 3. Experimental Analysis
  50. [50]
    Robust Hole-Detection in Triangular Meshes Irrespective of the ...
    In this work, we present a boundary and hole detection approach that traverses all the boundaries of an edge-manifold triangular mesh, irrespectively of the ...
  51. [51]
    [PDF] Computer Graphics: Effects of Origins
    In the mid and late 1970s further increases in speed and memory led LO raster graphics and then to displays of three-dimensional colored, shaded and textured ...
  52. [52]
    [PDF] Real-time Rendering Techniques with Hardware Tessellation
    Highly-tessellated meshes result in large memory foot- prints in GPU memory and are costly to render. In contrast, hardware tessellation allows for more output ...
  53. [53]
    Fast, Minimum Storage Ray-Triangle Intersection
    We present a clean algorithm for determining whether a ray intersects a triangle. The algorithm translates the origin of the ray and then changes the base.
  54. [54]
    Introduction to Mesh LOD - Unity - Manual
    See in Glossary reduces the number of polygons Unity has to draw and provides automatic LOD creation. Mesh LOD creates LODs automatically on model import and ...
  55. [55]
    Normal map (Bump mapping) - Unity - Manual
    Normal maps are a type of Bump Map. They are a special kind of texture that allow you to add surface detail such as bumps, grooves, and scratches to a model ...
  56. [56]
    [PDF] ( ~ ~ ' Computer Graphics, Volume 21, Number 4, July 1987
    Reyes is an image rendering system developed at Lucasfilm Ltd. and currently in use at Pixar. In designing Reyes, our goal was an architecture optimized for ...
  57. [57]
    Understanding Nanite 5's new virtualized geometry system
    Nanite uses a new internal mesh format and rendering technology to render pixel scale detail and high object counts.
  58. [58]
    Crash course on CAD data. Part 3 – BRep vs. Mesh
    Jan 16, 2020 · B-Rep (Boundary Representation) and polygonal (mesh) are two key types of representations used in CAD. Let's consider each one in more details.
  59. [59]
    THE MESH in CAE Simulations when using the Finite Element Method
    Apr 30, 2024 · Therefore, we define the process of meshing as the way which involves discretizing the CAD geometry into polygonal (finite) elements. This ...
  60. [60]
    Chapter 16. Legacy Polygon and Polyface Meshes
    The first surface entities implemented in AutoCAD (Release 10, 1989) were the PolygonMesh and the PolyfaceMesh. The PolygonMesh object consists in a ...
  61. [61]
    [PDF] Efficient Collision Detection Using Bounding Volume Hierarchies of ...
    One leading system publicly available for performing collision detection among arbitrary polygonal models is the. “RAPID” system, which is also based on a ...
  62. [62]
    [PDF] Fluid Animation from Simulation on Tetrahedral Meshes
    Dec 17, 2007 · First, because the size of the tetrahedra can vary over the domain, computational resources can be allocated efficiently by placing many small ...Missing: polygon | Show results with:polygon
  63. [63]
    Optimised Topology, The Mathematics of Lightweighting | Articles
    Jul 1, 2024 · A Minimum Mass Reduction of 30%. Whilst still new technology, Sarginsons has achieved a mass reduction of over 30% on every casting it has ...
  64. [64]
    A mass-spring model for surface mesh deformation based on shape ...
    In this paper, we propose a mass-spring model based on shape matching for real-time deformable modeling in virtual reality systems.
  65. [65]
    A Hybrid Method for 3D Reconstruction of MR Images - PMC - NIH
    Apr 7, 2022 · These regions, representing a segmentation map, are then converted into 3D meshes in order to be observed or used for therapeutic planning and ...
  66. [66]
    Fast cortical surface reconstruction from MRI using deep learning
    Mar 9, 2022 · Using 1-mm isotropic T1-weighted images, the FastCSR pipeline was able to reconstruct a subject's cortical surfaces within 5 min with comparable ...
  67. [67]
    Hybrid computed tomography and magnetic resonance imaging 3D ...
    The printable model encloses a 3D surface defined by several triangular facets to fit these surfaces, forming a truly triangle mesh, which is formed by ...
  68. [68]
    Hybrid rendering of multidimensional image data - PubMed
    The most important rendering methods applied in medical imaging are surface and volume rendering techniques. Each approach has its own advantages and ...Missing: meshes | Show results with:meshes
  69. [69]
    A hybrid ray tracer for rendering polygon and volume data
    Volume rendering, a technique for visualizing sampled functions of three spatial dimensions by computing 2-D projections of a colored semitransparent volume ...Missing: meshes | Show results with:meshes
  70. [70]
    Exploring the visible human using the VOXEL-MAN framework
    Aug 6, 2025 · Voxel-Man, a monoscopic 3D anatomical atlas, created interactive perspective views of the Visible Human data set and produced QTVR movies ( ...
  71. [71]
    Regularised marching tetrahedra: improved iso-surface extraction
    We present a new algorithm, called marching cubes, that creates triangle models of constant density surfaces from 3D medical data. Using a divide-and ...
  72. [72]
    A complex geometry isosurface reconstruction algorithm for particle ...
    This paper presents a new preprocessing algorithm to generate accurate initial conditions for particle-method-based CFD simulations with complex geometries.
  73. [73]
    [PDF] MeshSDF: Differentiable Iso-Surface Extraction
    MeshSDF is a differentiable method to produce explicit surface mesh representations from Deep Signed Distance Functions, which can vary its topology.
  74. [74]
    [PDF] Feature-Preserving Adaptive Mesh Generation for Molecular Shape ...
    We describe a chain of algorithms for molecular surface and volumetric mesh generation. We take as inputs the centers and radii of all atoms of a molecule ...
  75. [75]
    TMSmesh: A Robust Method for Molecular Surface Mesh Generation ...
    TMSmesh has a linear complexity with respect to the number of atoms and is shown to be capable of handling molecules consisting of more than one million atoms, ...
  76. [76]
    MedGS: Gaussian Splatting for Multi-Modal 3D Medical Imaging
    Sep 20, 2025 · In this framework, medical imaging data are represented as consecutive two-dimensional (2D) frames embedded in 3D space and modeled using ...
  77. [77]
    A Foundation Model for Real-time Photorealistic Volumetric Rendering
    May 22, 2025 · Volumetric rendering of Computed Tomography (CT) scans is crucial for visualizing complex 3D anatomical structures in medical imaging.
  78. [78]
    Survey of methods and principles in three-dimensional ...
    Jul 27, 2023 · All medical imaging-based 3D reconstructions are modeled using a point set [26]; the surface is represented as a mesh of triangles [27] or an ...
  79. [79]
    [PDF] B1. Object Files (.obj) - Paul Bourke
    Object files define the geometry and other properties for objects in Wavefront's Advanced Visualizer. Object files can also be used to transfer geometric data ...
  80. [80]
    STL (STereoLithography) File Format, Binary - Library of Congress
    Feb 27, 2025 · STL is a simple, openly documented format for describing an object's surface as a triangular mesh, used for rapid prototyping and 3D printing.Identification and description · Sustainability factors · File type signifiers
  81. [81]
    STL format - Paul Bourke
    STL (STereo Lithography) format is a standard for rapid prototyping, available in ASCII and binary. It uses 3 vertex facets, and adjacent facets share two ...<|separator|>
  82. [82]
    Polygon File Format (PLY) Family - The Library of Congress
    Feb 20, 2025 · The PLY file format is a simple format for describing an object as a polygonal model. The format originated at the Stanford Computer Graphics ...Identification and description · Sustainability factors · File type signifiers
  83. [83]
    [PDF] PLY polygon file format - GAMMA
    This document presents the PLY polygon file format, a format for storing graphical objects that are described as a collection of polygons. Our goal is.
  84. [84]
    glTF™ 2.0 Specification - Khronos Registry
    Oct 11, 2021 · glTF is an API-neutral runtime asset delivery format. glTF bridges the gap between 3D content creation tools and modern graphics applications.Foreword · Concepts · GLB File Format Specification · Properties Reference
  85. [85]
    FBX | Adaptable File Formats for 3D Animation Software - Autodesk
    FBX® data exchange technology is a 3D asset exchange format that facilitates higher-fidelity data exchange between 3ds Max, Maya, MotionBuilder, ...
  86. [86]
    Introduction to Polygon Meshes - Scratchapixel
    In this chapter we will look at how polygon meshes are stored in three of the most common file formats: RIB (RenderMan), OBJ, and FBX.Missing: specialized | Show results with:specialized
  87. [87]
    3DS File Format
    A 3DS file is a 3D mesh format used by Autodesk 3D Studio, containing data for 3D scenes and images. It is a binary file format with data stored in chunks.What is 3DS file? · 3DS File Format - More... · 3DS Chunk
  88. [88]
    3D-Studio File Format (.3ds) - Paul Bourke
    3D-Studio File Format (.3ds). From Autodesk Ltd, Document Revision 0.91. Original by Jim Pitts Edited by Paul Bourke June 1996. A warning beforehand.
  89. [89]
    Maya Help | Supported data export formats | Autodesk
    Note: Since Maya 2014, Maya Binary (.mb) files use 64-bit indices and can be larger than 2.0 GB. Scenes exported as .mb files are not compatible with earlier ...
  90. [90]
    MB - Maya Binary File Format
    MB files contain information such as geometry, lighting, animation, and rendering for defining the 3D scenes. Autodesk Maya 2020 can be used to open .mb files.
  91. [91]
    What file formats does 3ds Max import and export? - Autodesk
    Jun 9, 2020 · 3ds Max imports formats like .FBX, .3DS, .ABC, .AI, .DAE, .OBJ, .RVT, .STL, and .USD. It exports formats like .FBX, .3DS, .ABC, .AI, .DAE, .DWG ...
  92. [92]
    [PDF] The RenderMan Interface - Paul Bourke
    This section lays out a set of RIB file format conventions which are patterned loosely after ... and violates Pixar's proprietary rights, and Pixar will enforce ...
  93. [93]
    8 Best 3D File Formats You Should Use in 2025 - The Pixel Lab
    A proprietary 3D file type is a format that is specific to a particular software or company. Examples of proprietary file formats include .max (3ds Max), .blend ...
  94. [94]
    A Comprehensive Guide of 3D Model Formats (2025) - VividWorks
    Jul 25, 2024 · Discover the comprehensive guide to 3D model formats, including technical details, use cases, and pros and cons of popular formats such as GLTF/GLB, OBJ, FBX, ...