trimesh#
mikedh/trimesh#
Trimesh is a pure Python (2.7- 3.3+) library for loading and using triangular meshes with an emphasis on watertight meshes. The goal of the library is to provide a fully featured Trimesh object which allows for easy manipulation and analysis, in the style of the Polygon object in the Shapely library.
- class Trimesh[source]#
- __init__(vertices=None, faces=None, face_normals=None, vertex_normals=None, face_colors=None, vertex_colors=None, face_attributes=None, vertex_attributes=None, metadata=None, process=True, validate=False, merge_tex=None, merge_norm=None, use_embree=True, initial_cache=None, visual=None, **kwargs)[source]#
A Trimesh object contains a triangular 3D mesh.
- Parameters:
vertices ((n, 3) float) β Array of vertex locations
faces ((m, 3) or (m, 4) int) β Array of triangular or quad faces (triangulated on load)
face_normals ((m, 3) float) β Array of normal vectors corresponding to faces
vertex_normals ((n, 3) float) β Array of normal vectors for vertices
metadata (dict) β Any metadata about the mesh
process (bool) β if True, Nan and Inf values will be removed immediately and vertices will be merged
validate (bool) β If True, degenerate and duplicate faces will be removed immediately, and some functions will alter the mesh to ensure consistent results.
use_embree (bool) β If True try to use pyembree raytracer. If pyembree is not available it will automatically fall back to a much slower rtree/numpy implementation
initial_cache (dict) β A way to pass things to the cache in case expensive things were calculated before creating the mesh object.
visual (ColorVisuals or TextureVisuals) β Assigned to self.visual
- process(validate=False, merge_tex=None, merge_norm=None)[source]#
Do processing to make a mesh useful.
- Does this by:
removing NaN and Inf values
merging duplicate vertices
- If validate:
Remove triangles which have one edge of their 2D oriented bounding box shorter than tol.merge
remove duplicated triangles
ensure triangles are consistently wound and normals face outwards
- Parameters:
validate (bool) β Remove degenerate and duplicate faces.
- Returns:
self β Current mesh
- Return type:
- property faces#
The faces of the mesh.
This is regarded as core information which cannot be regenerated from cache and as such is stored in self._data which tracks the array for changes and clears cached values of the mesh altered.
- Returns:
faces β References for self.vertices for triangles.
- Return type:
(n, 3) int64
- property faces_sparse#
A sparse matrix representation of the faces.
- Returns:
sparse β Has properties: dtype : bool shape : (len(self.vertices), len(self.faces))
- Return type:
scipy.sparse.coo_matrix
- property face_normals#
Return the unit normal vector for each face.
If a face is degenerate and a normal canβt be generated a zero magnitude unit vector will be returned for that face.
- Returns:
normals β Normal vectors of each face
- Return type:
(len(self.faces), 3) np.float64
- property vertices#
The vertices of the mesh.
This is regarded as core information which cannot be generated from cache and as such is stored in self._data which tracks the array for changes and clears cached values of the mesh if this is altered.
- Returns:
vertices β Points in cartesian space referenced by self.faces
- Return type:
(n, 3) float
- property vertex_normals#
The vertex normals of the mesh. If the normals were loaded we check to make sure we have the same number of vertex normals and vertices before returning them. If there are no vertex normals defined or a shape mismatch we calculate the vertex normals from the mean normals of the faces the vertex is used in.
- Returns:
vertex_normals β Represents the surface normal at each vertex. Where n == len(self.vertices)
- Return type:
(n, 3) float
- property vertex_faces#
A representation of the face indices that correspond to each vertex.
- Returns:
vertex_faces β Each row contains the face indices that correspond to the given vertex, padded with -1 up to the max number of faces corresponding to any one vertex Where n == len(self.vertices), m == max number of faces for a single vertex
- Return type:
(n,m) int
- property bounds#
The axis aligned bounds of the faces of the mesh.
- Returns:
bounds β Bounding box with [min, max] coordinates If mesh is empty will return None
- Return type:
(2, 3) float or None
- property extents#
The length, width, and height of the axis aligned bounding box of the mesh.
- Returns:
extents β Array containing axis aligned [length, width, height] If mesh is empty returns None
- Return type:
(3, ) float or None
- property scale#
A metric for the overall scale of the mesh, the length of the diagonal of the axis aligned bounding box of the mesh.
- Returns:
scale β The length of the meshes AABB diagonal
- Return type:
float
- property centroid#
The point in space which is the average of the triangle centroids weighted by the area of each triangle.
This will be valid even for non-watertight meshes, unlike self.center_mass
- Returns:
centroid β The average vertex weighted by face area
- Return type:
(3, ) float
- property center_mass#
The point in space which is the center of mass/volume.
If the current mesh is not watertight this is meaningless garbage unless it was explicitly set.
- Returns:
center_mass β Volumetric center of mass of the mesh
- Return type:
(3, ) float
- property density#
The density of the mesh.
- Returns:
density β The density of the mesh.
- Return type:
float
- property volume#
Volume of the current mesh calculated using a surface integral. If the current mesh isnβt watertight this is garbage.
- Returns:
volume β Volume of the current mesh
- Return type:
float
- property mass#
Mass of the current mesh, based on specified density and volume. If the current mesh isnβt watertight this is garbage.
- Returns:
mass β Mass of the current mesh
- Return type:
float
- property moment_inertia#
Return the moment of inertia matrix of the current mesh. If mesh isnβt watertight this is garbage. The returned moment of inertia is axis aligned at the meshβs center of mass mesh.center_mass. If you want the moment at any other frame including the origin call: mesh.moment_inertia_frame
- Returns:
inertia β Moment of inertia of the current mesh at the center of mass and aligned with the cartesian axis.
- Return type:
(3, 3) float
- moment_inertia_frame(transform)[source]#
Get the moment of inertia of this mesh with respect to an arbitrary frame, versus with respect to the center of mass as returned by mesh.moment_inertia.
For example if transform is an identity matrix np.eye(4) this will give the moment at the origin.
Uses the parallel axis theorum to move the center mass tensor to this arbitrary frame.
- Parameters:
transform ((4, 4) float) β Homogeneous transformation matrix.
- Returns:
inertia β Moment of inertia in the requested frame.
- Return type:
(3, 3)
- property principal_inertia_components#
Return the principal components of inertia
Ordering corresponds to mesh.principal_inertia_vectors
- Returns:
components β Principal components of inertia
- Return type:
(3, ) float
- property principal_inertia_vectors#
Return the principal axis of inertia as unit vectors. The order corresponds to mesh.principal_inertia_components.
- Returns:
vectors β Three vectors pointing along the principal axis of inertia directions
- Return type:
(3, 3) float
- property principal_inertia_transform#
A transform which moves the current mesh so the principal inertia vectors are on the X,Y, and Z axis, and the centroid is at the origin.
- Returns:
transform β Homogeneous transformation matrix
- Return type:
(4, 4) float
- property symmetry#
Check whether a mesh has rotational symmetry around an axis (radial) or point (spherical).
- Returns:
symmetry β What kind of symmetry does the mesh have.
- Return type:
None, βradialβ, βsphericalβ
- property symmetry_axis#
If a mesh has rotational symmetry, return the axis.
- Returns:
axis β Axis around which a 2D profile was revolved to create this mesh.
- Return type:
(3, ) float
- property symmetry_section#
If a mesh has rotational symmetry return the two vectors which make up a section coordinate frame.
- Returns:
section β Vectors to take a section along
- Return type:
(2, 3) float
- property triangles#
Actual triangles of the mesh (points, not indexes)
- Returns:
triangles β Points of triangle vertices
- Return type:
(n, 3, 3) float
- property triangles_tree#
An R-tree containing each face of the mesh.
- Returns:
tree β Each triangle in self.faces has a rectangular cell
- Return type:
rtree.index
- property triangles_center#
The center of each triangle (barycentric [1/3, 1/3, 1/3])
- Returns:
triangles_center β Center of each triangular face
- Return type:
(len(self.faces), 3) float
- property triangles_cross#
The cross product of two edges of each triangle.
- Returns:
crosses β Cross product of each triangle
- Return type:
(n, 3) float
- property edges#
Edges of the mesh (derived from faces).
- Returns:
edges β List of vertex indices making up edges
- Return type:
(n, 2) int
- property edges_face#
Which face does each edge belong to.
- Returns:
edges_face β Index of self.faces
- Return type:
(n, ) int
- property edges_unique#
The unique edges of the mesh.
- Returns:
edges_unique β Vertex indices for unique edges
- Return type:
(n, 2) int
- property edges_unique_length#
How long is each unique edge.
- Returns:
length β Length of each unique edge
- Return type:
(len(self.edges_unique), ) float
- property edges_unique_inverse#
Return the inverse required to reproduce self.edges_sorted from self.edges_unique.
Useful for referencing edge properties: mesh.edges_unique[mesh.edges_unique_inverse] == m.edges_sorted
- Returns:
inverse β Indexes of self.edges_unique
- Return type:
(len(self.edges), ) int
- property edges_sorted#
Edges sorted along axis 1
- Returns:
edges_sorted β Same as self.edges but sorted along axis 1
- Return type:
(n, 2)
- property edges_sorted_tree#
A KDTree for mapping edges back to edge index.
- Returns:
tree β Tree when queried with edges will return their index in mesh.edges_sorted
- Return type:
scipy.spatial.cKDTree
- property edges_sparse#
Edges in sparse bool COO graph format where connected vertices are True.
- Returns:
sparse β Sparse graph in COO format
- Return type:
(len(self.vertices), len(self.vertices)) bool
- property body_count#
How many connected groups of vertices exist in this mesh. Note that this number may differ from result in mesh.split, which is calculated from FACE rather than vertex adjacency.
- Returns:
count β Number of connected vertex groups
- Return type:
int
- property faces_unique_edges#
For each face return which indexes in mesh.unique_edges constructs that face.
- Returns:
faces_unique_edges β Indexes of self.edges_unique that construct self.faces
- Return type:
(len(self.faces), 3) int
Examples
In [0]: mesh.faces[:2] Out[0]: TrackedArray([[ 1, 6946, 24224],
[ 6946, 1727, 24225]])
In [1]: mesh.edges_unique[mesh.faces_unique_edges[:2]] Out[1]: array([[[ 1, 6946],
[ 6946, 24224], [ 1, 24224]],
- [[ 1727, 6946],
[ 1727, 24225], [ 6946, 24225]]])
- property euler_number#
Return the Euler characteristic (a topological invariant) for the mesh In order to guarantee correctness, this should be called after remove_unreferenced_vertices
- Returns:
euler_number β Topological invariant
- Return type:
int
- property referenced_vertices#
Which vertices in the current mesh are referenced by a face.
- Returns:
referenced β Which vertices are referenced by a face
- Return type:
(len(self.vertices), ) bool
- property units#
Definition of units for the mesh.
- Returns:
units β Unit system mesh is in, or None if not defined
- Return type:
str
- convert_units(desired, guess=False)[source]#
Convert the units of the mesh into a specified unit.
- Parameters:
desired (string) β Units to convert to (eg βinchesβ)
guess (boolean) β If self.units are not defined should we guess the current units of the document and then convert?
- merge_vertices(merge_tex=None, merge_norm=None, digits_vertex=None, digits_norm=None, digits_uv=None)[source]#
Removes duplicate vertices grouped by position and optionally texture coordinate and normal.
- Parameters:
mesh (Trimesh object) β Mesh to merge vertices on
merge_tex (bool) β If True textured meshes with UV coordinates will have vertices merged regardless of UV coordinates
merge_norm (bool) β If True, meshes with vertex normals will have vertices merged ignoring different normals
digits_vertex (None or int) β Number of digits to consider for vertex position
digits_norm (int) β Number of digits to consider for unit normals
digits_uv (int) β Number of digits to consider for UV coordinates
- update_vertices(mask, inverse=None)[source]#
Update vertices with a mask.
- Parameters:
vertex_mask ((len(self.vertices)) bool) β Array of which vertices to keep
inverse ((len(self.vertices)) int) β Array to reconstruct vertex references such as output by np.unique
- update_faces(mask)[source]#
In many cases, we will want to remove specific faces. However, there is additional bookkeeping to do this cleanly. This function updates the set of faces with a validity mask, as well as keeping track of normals and colors.
- Parameters:
valid β Mask to remove faces
- remove_infinite_values()[source]#
Ensure that every vertex and face consists of finite numbers. This will remove vertices or faces containing np.nan and np.inf
Alters self.faces and self.vertices
- remove_duplicate_faces()[source]#
On the current mesh remove any faces which are duplicates.
Alters self.faces to remove duplicate faces
- rezero()[source]#
Translate the mesh so that all vertex vertices are positive.
Alters self.vertices.
- split(**kwargs)#
Returns a list of Trimesh objects, based on face connectivity. Splits into individual components, sometimes referred to as βbodiesβ
- Parameters:
only_watertight (bool) β Only return watertight meshes and discard remainder
adjacency (None or (n, 2) int) β Override face adjacency with custom values
- Returns:
meshes β Separate bodies from original mesh
- Return type:
(n, ) trimesh.Trimesh
- property face_adjacency#
Find faces that share an edge i.e. βadjacentβ faces.
- Returns:
adjacency β Pairs of faces which share an edge
- Return type:
(n, 2) int
Examples
In [1]: mesh = trimesh.load(βmodels/featuretype.STLβ)
In [2]: mesh.face_adjacency Out[2]: array([[ 0, 1],
[ 2, 3], [ 0, 3], β¦, [1112, 949], [3467, 3475], [1113, 3475]])
In [3]: mesh.faces[mesh.face_adjacency[0]] Out[3]: TrackedArray([[ 1, 0, 408],
[1239, 0, 1]], dtype=int64)
In [4]: import networkx as nx
In [5]: graph = nx.from_edgelist(mesh.face_adjacency)
In [6]: groups = nx.connected_components(graph)
- property face_neighborhood#
Find faces that share a vertex i.e. βneighborsβ faces.
- Returns:
neighborhood β Pairs of faces which share a vertex
- Return type:
(n, 2) int
- property face_adjacency_edges#
Returns the edges that are shared by the adjacent faces.
- Returns:
edges β Vertex indices which correspond to face_adjacency
- Return type:
(n, 2) int
- property face_adjacency_edges_tree#
A KDTree for mapping edges back face adjacency index.
- Returns:
tree β Tree when queried with SORTED edges will return their index in mesh.face_adjacency
- Return type:
scipy.spatial.cKDTree
- property face_adjacency_angles#
Return the angle between adjacent faces
- Returns:
adjacency_angle β Angle between adjacent faces Each value corresponds with self.face_adjacency
- Return type:
(n, ) float
- property face_adjacency_projections#
The projection of the non-shared vertex of a triangle onto its adjacent face
- Returns:
projections β Dot product of vertex onto plane of adjacent triangle.
- Return type:
(len(self.face_adjacency), ) float
- property face_adjacency_convex#
Return faces which are adjacent and locally convex.
What this means is that given faces A and B, the one vertex in B that is not shared with A, projected onto the plane of A has a projection that is zero or negative.
- Returns:
are_convex β Face pairs that are locally convex
- Return type:
(len(self.face_adjacency), ) bool
Return the vertex index of the two vertices not in the shared edge between two adjacent faces
- Returns:
vid_unshared β Indexes of mesh.vertices
- Return type:
(len(mesh.face_adjacency), 2) int
- property face_adjacency_radius#
The approximate radius of a cylinder that fits inside adjacent faces.
- Returns:
radii β Approximate radius formed by triangle pair
- Return type:
(len(self.face_adjacency), ) float
- property face_adjacency_span#
The approximate perpendicular projection of the non-shared vertices in a pair of adjacent faces onto the shared edge of the two faces.
- Returns:
span β Approximate span between the non-shared vertices
- Return type:
(len(self.face_adjacency), ) float
- property integral_mean_curvature#
The integral mean curvature, or the surface integral of the mean curvature.
- Returns:
area β Integral mean curvature of mesh
- Return type:
float
- property vertex_adjacency_graph#
Returns a networkx graph representing the vertices and their connections in the mesh.
- Returns:
graph β Graph representing vertices and edges between them where vertices are nodes and edges are edges
- Return type:
networkx.Graph
Examples
This is useful for getting nearby vertices for a given vertex, potentially for some simple smoothing techniques.
mesh = trimesh.primitives.Box() graph = mesh.vertex_adjacency_graph graph.neighbors(0) > [1, 2, 3, 4]
- property vertex_neighbors#
The vertex neighbors of each vertex of the mesh, determined from the cached vertex_adjacency_graph, if already existent.
- Returns:
vertex_neighbors β Represents immediate neighbors of each vertex along the edge of a triangle
- Return type:
(len(self.vertices), ) int
Examples
This is useful for getting nearby vertices for a given vertex, potentially for some simple smoothing techniques.
>>> mesh = trimesh.primitives.Box() >>> mesh.vertex_neighbors[0] [1, 2, 3, 4]
- property is_winding_consistent#
Does the mesh have consistent winding or not. A mesh with consistent winding has each shared edge going in an opposite direction from the other in the pair.
- Returns:
consistent β Is winding is consistent or not
- Return type:
bool
- property is_watertight#
Check if a mesh is watertight by making sure every edge is included in two faces.
- Returns:
is_watertight β Is mesh watertight or not
- Return type:
bool
- property is_volume#
Check if a mesh has all the properties required to represent a valid volume, rather than just a surface.
These properties include being watertight, having consistent winding and outward facing normals.
- Returns:
valid β Does the mesh represent a volume
- Return type:
bool
- property is_empty#
Does the current mesh have data defined.
- Returns:
empty β If True, no data is set on the current mesh
- Return type:
bool
- property is_convex#
Check if a mesh is convex or not.
- Returns:
is_convex β Is mesh convex or not
- Return type:
bool
- property kdtree#
Return a scipy.spatial.cKDTree of the vertices of the mesh. Not cached as this lead to observed memory issues and segfaults.
- Returns:
tree β Contains mesh.vertices
- Return type:
scipy.spatial.cKDTree
- remove_degenerate_faces(height=1e-08)[source]#
Remove degenerate faces (faces without 3 unique vertex indices) from the current mesh.
If a height is specified, it will remove any face with a 2D oriented bounding box with one edge shorter than that height.
If not specified, it will remove any face with a zero normal.
- Parameters:
height (float) β If specified removes faces with an oriented bounding box shorter than this on one side.
- Returns:
nondegenerate β Mask used to remove faces
- Return type:
(len(self.faces), ) bool
- property facets#
Return a list of face indices for coplanar adjacent faces.
- Returns:
facets β Groups of indexes of self.faces
- Return type:
(n, ) sequence of (m, ) int
- property facets_area#
Return an array containing the area of each facet.
- Returns:
area β Total area of each facet (group of faces)
- Return type:
(len(self.facets), ) float
- property facets_normal#
Return the normal of each facet
- Returns:
normals β A unit normal vector for each facet
- Return type:
(len(self.facets), 3) float
- property facets_origin#
Return a point on the facet plane.
- Returns:
origins β A point on each facet plane
- Return type:
(len(self.facets), 3) float
- property facets_boundary#
Return the edges which represent the boundary of each facet
- Returns:
edges_boundary β Indices of self.vertices
- Return type:
sequence of (n, 2) int
- property facets_on_hull#
Find which facets of the mesh are on the convex hull.
- Returns:
on_hull β is A facet on the meshes convex hull or not
- Return type:
(len(mesh.facets), ) bool
- fix_normals(**kwargs)#
Find and fix problems with self.face_normals and self.faces winding direction.
For face normals ensure that vectors are consistently pointed outwards, and that self.faces is wound in the correct direction for all connected components.
- Parameters:
multibody (None or bool) β Fix normals across multiple bodies if None automatically pick from body_count
- fill_holes()[source]#
Fill single triangle and single quad holes in the current mesh.
- Returns:
watertight β Is the mesh watertight after the function completes
- Return type:
bool
- register(other, **kwargs)[source]#
Align a mesh with another mesh or a PointCloud using the principal axes of inertia as a starting point which is refined by iterative closest point.
- Parameters:
mesh (trimesh.Trimesh object) β Mesh to align with other
other (trimesh.Trimesh or (n, 3) float) β Mesh or points in space
samples (int) β Number of samples from mesh surface to align
icp_first (int) β How many ICP iterations for the 9 possible combinations of
icp_final (int) β How many ICP itertations for the closest candidate from the wider search
- Returns:
mesh_to_other ((4, 4) float) β Transform to align mesh to the other object
cost (float) β Average square distance per point
- compute_stable_poses(center_mass=None, sigma=0.0, n_samples=1, threshold=0.0)[source]#
Computes stable orientations of a mesh and their quasi-static probabilities.
This method samples the location of the center of mass from a multivariate gaussian (mean at com, cov equal to identity times sigma) over n_samples. For each sample, it computes the stable resting poses of the mesh on a a planar workspace and evaluates the probabilities of landing in each pose if the object is dropped onto the table randomly.
This method returns the 4x4 homogeneous transform matrices that place the shape against the planar surface with the z-axis pointing upwards and a list of the probabilities for each pose. The transforms and probabilties that are returned are sorted, with the most probable pose first.
- Parameters:
center_mass ((3, ) float) β The object center of mass (if None, this method assumes uniform density and watertightness and computes a center of mass explicitly)
sigma (float) β The covariance for the multivariate gaussian used to sample center of mass locations
n_samples (int) β The number of samples of the center of mass location
threshold (float) β The probability value at which to threshold returned stable poses
- Returns:
transforms ((n, 4, 4) float) β The homogeneous matrices that transform the object to rest in a stable pose, with the new z-axis pointing upwards from the table and the object just touching the table.
probs ((n, ) float) β A probability ranging from 0.0 to 1.0 for each pose
- subdivide(face_index=None)[source]#
Subdivide a mesh, with each subdivided face replaced with four smaller faces.
- Parameters:
face_index ((m, ) int or None) β If None all faces of mesh will be subdivided If (m, ) int array of indices: only specified faces will be subdivided. Note that in this case the mesh will generally no longer be manifold, as the additional vertex on the midpoint will not be used by the adjacent faces to the faces specified, and an additional postprocessing step will be required to make resulting mesh watertight
- subdivide_to_size(max_edge, max_iter=10, return_index=False)[source]#
Subdivide a mesh until every edge is shorter than a specified length.
Will return a triangle soup, not a nicely structured mesh.
- Parameters:
max_edge (float) β Maximum length of any edge in the result
max_iter (int) β The maximum number of times to run subdivision
return_index (bool) β If True, return index of original face for new faces
- subdivide_loop(iterations=None)[source]#
Subdivide a mesh by dividing each triangle into four triangles and approximating their smoothed surface using loop subdivision. Loop subdivision often looks better on triangular meshes than catmul-clark, which operates primarily on quads.
- Parameters:
iterations (int) β Number of iterations to run subdivision.
multibody (bool) β If True will try to subdivide for each submesh
- smoothed(**kwargs)#
Return a version of the current mesh which will render nicely, without changing source mesh.
- Parameters:
angle (float or None) β Angle in radians face pairs with angles smaller than this will appear smoothed
facet_minarea (float or None) β Minimum area fraction to consider IE for facets_minarea=25 only facets larger than mesh.area / 25 will be considered.
- Returns:
smoothed β Non watertight version of current mesh which will render nicely with smooth shading
- Return type:
- property visual#
Get the stored visuals for the current mesh.
- Returns:
visual β Contains visual information about the mesh
- Return type:
ColorVisuals or TextureVisuals
- section(plane_normal, plane_origin, **kwargs)[source]#
Returns a 3D cross section of the current mesh and a plane defined by origin and normal.
- Parameters:
plane_normal β Normal vector of section plane
plane_origin ((3, ) float) β Point on the cross section plane
- Returns:
intersections β Curve of intersection
- Return type:
Path3D or None
- section_multiplane(plane_origin, plane_normal, heights)[source]#
Return multiple parallel cross sections of the current mesh in 2D.
- Parameters:
plane_origin ((3, ) float) β Point on the cross section plane
plane_normal β Normal vector of section plane
heights ((n, ) float) β Each section is offset by height along the plane normal.
- Returns:
paths β 2D cross sections at specified heights. path.metadata[βto_3Dβ] contains transform to return 2D section back into 3D space.
- Return type:
(n, ) Path2D or None
- slice_plane(plane_origin, plane_normal, cap=False, face_index=None, cached_dots=None, **kwargs)[source]#
Slice the mesh with a plane, returning a new mesh that is the portion of the original mesh to the positive normal side of the plane
- plane_origin(3,) float
Point on plane to intersect with mesh
- plane_normal(3,) float
Normal vector of plane to intersect with mesh
- capbool
If True, cap the result with a triangulated polygon
- face_index((m,) int)
Indexes of mesh.faces to slice. When no mask is provided, the default is to slice all faces.
- cached_dots(n, 3) float
If an external function has stored dot products pass them here to avoid recomputing
- Returns:
new_mesh β Subset of current mesh that intersects the half plane to the positive normal side of the plane
- Return type:
trimesh.Trimesh or None
- unwrap(image=None)[source]#
Returns a Trimesh object equivalent to the current mesh where the vertices have been assigned uv texture coordinates. Vertices may be split into as many as necessary by the unwrapping algorithm, depending on how many uv maps they appear in.
Requires pip install xatlas
- Parameters:
image (None or PIL.Image) β Image to assign to the material
- Returns:
unwrapped β Mesh with unwrapped uv coordinates
- Return type:
- property convex_hull#
Returns a Trimesh object representing the convex hull of the current mesh.
- Returns:
convex β Mesh of convex hull of current mesh
- Return type:
- sample(count, return_index=False, face_weight=None)[source]#
Return random samples distributed across the surface of the mesh
- Parameters:
count (int) β Number of points to sample
return_index (bool) β If True will also return the index of which face each sample was taken from.
face_weight (None or len(mesh.faces) float) β Weight faces by a factor other than face area. If None will be the same as face_weight=mesh.area
- Returns:
samples ((count, 3) float) β Points on surface of mesh
face_index ((count, ) int) β Index of self.faces
- remove_unreferenced_vertices()[source]#
Remove all vertices in the current mesh which are not referenced by a face.
- unmerge_vertices()[source]#
Removes all face references so that every face contains three unique vertex indices and no faces are adjacent.
- apply_transform(matrix)[source]#
Transform mesh by a homogeneous transformation matrix.
Does the bookkeeping to avoid recomputing things so this function should be used rather than directly modifying self.vertices if possible.
- Parameters:
matrix ((4, 4) float) β Homogeneous transformation matrix
- voxelized(pitch, method='subdivide', **kwargs)[source]#
Return a VoxelGrid object representing the current mesh discretized into voxels at the specified pitch
- Parameters:
pitch (float) β The edge length of a single voxel
method (implementation key. See trimesh.voxel.creation.voxelizers) β
**kwargs (additional kwargs passed to the specified implementation.) β
- Returns:
voxelized β Representing the current mesh
- Return type:
VoxelGrid object
- property as_open3d#
Return an open3d.geometry.TriangleMesh version of the current mesh.
- Returns:
open3d β Current mesh as an open3d object.
- Return type:
open3d.geometry.TriangleMesh
- simplify_quadratic_decimation(*args, **kwargs)[source]#
DERECATED MARCH 2024 REPLACE WITH: mesh.simplify_quadric_decimation
- simplify_quadric_decimation(face_count)[source]#
A thin wrapper around the open3d implementation of this: open3d.geometry.TriangleMesh.simplify_quadric_decimation
- Parameters:
face_count (int) β Number of faces desired in the resulting mesh.
- Returns:
simple β Simplified version of mesh.
- Return type:
- outline(face_ids=None, **kwargs)[source]#
Given a list of face indexes find the outline of those faces and return it as a Path3D.
The outline is defined here as every edge which is only included by a single triangle.
Note that this implies a non-watertight mesh as the outline of a watertight mesh is an empty path.
- Parameters:
face_ids ((n, ) int) β Indices to compute the outline of. If None, outline of full mesh will be computed.
**kwargs (passed to Path3D constructor) β
- Returns:
path β Curve in 3D of the outline
- Return type:
Path3D
- projected(normal, **kwargs)[source]#
Project a mesh onto a plane and then extract the polygon that outlines the mesh projection on that plane.
- Parameters:
mesh (trimesh.Trimesh) β Source geometry
check (bool) β If True make sure is flat
normal ((3,) float) β Normal to extract flat pattern along
origin (None or (3,) float) β Origin of plane to project mesh onto
pad (float) β Proportion to pad polygons by before unioning and then de-padding result by to avoid zero-width gaps.
tol_dot (float) β Tolerance for discarding on-edge triangles.
max_regions (int) β Raise an exception if the mesh has more than this number of disconnected regions to fail quickly before unioning.
- Returns:
projected β Outline of source mesh
- Return type:
trimesh.path.Path2D
- property area#
Summed area of all triangles in the current mesh.
- Returns:
area β Surface area of mesh
- Return type:
float
- property area_faces#
The area of each face in the mesh.
- Returns:
area_faces β Area of each face
- Return type:
(n, ) float
- property mass_properties#
Returns the mass properties of the current mesh.
Assumes uniform density, and result is probably garbage if mesh isnβt watertight.
- Returns:
properties β With keys: βvolumeβ : in global units^3 βmassβ : From specified density βdensityβ : Included again for convenience (same as kwarg density) βinertiaβ : Taken at the center of mass and aligned with global
coordinate system
βcenter_massβ : Center of mass location, in global coordinate system
- Return type:
dict
- invert()[source]#
Invert the mesh in-place by reversing the winding of every face and negating normals without dumping the cache.
Alters self.faces by reversing columns, and negating self.face_normals and self.vertex_normals.
- scene(**kwargs)[source]#
Returns a Scene object containing the current mesh.
- Returns:
scene β Contains just the current mesh
- Return type:
- show(**kwargs)[source]#
Render the mesh in an opengl window. Requires pyglet.
- Parameters:
smooth (bool) β Run smooth shading on mesh or not, large meshes will be slow
- Returns:
scene β Scene with current mesh in it
- Return type:
trimesh.scene.Scene
- submesh(faces_sequence, **kwargs)[source]#
Return a subset of the mesh.
- Parameters:
faces_sequence (sequence (m, ) int) β Face indices of mesh
only_watertight (bool) β Only return submeshes which are watertight
append (bool) β Return a single mesh which has the faces appended. if this flag is set, only_watertight is ignored
- Returns:
submesh β Single mesh if append or list of submeshes
- Return type:
- property identifier#
Return a float vector which is unique to the mesh and is robust to rotation and translation.
- Returns:
identifier β Identifying properties of the current mesh
- Return type:
(7,) float
- property identifier_hash#
A hash of the rotation invariant identifier vector.
- Returns:
hashed β Hex string of the SHA256 hash from the identifier vector at hand-tuned sigfigs.
- Return type:
str
- property identifier_md5#
- export(file_obj=None, file_type=None, **kwargs)[source]#
Export the current mesh to a file object. If file_obj is a filename, file will be written there.
Supported formats are stl, off, ply, collada, json, dict, glb, dict64, msgpack.
- Parameters:
file_obj (open writeable file object) β str, file name where to save the mesh None, return the export blob
file_type (str) β Which file type to export as, if file_name is passed this is not required.
- to_dict()[source]#
Return a dictionary representation of the current mesh with keys that can be used as the kwargs for the Trimesh constructor and matches the schema in: trimesh/resources/schema/primitive/trimesh.schema.json
- Returns:
result β Matches schema and Trimesh constructor.
- Return type:
dict
- convex_decomposition(maxhulls=20, **kwargs)[source]#
Compute an approximate convex decomposition of a mesh.
testVHACD Parameters which can be passed as kwargs:
Name Default#
resolution 100000 max. concavity 0.001 plane down-sampling 4 convex-hull down-sampling 4 alpha 0.05 beta 0.05 maxhulls 10 pca 0 mode 0 max. vertices per convex-hull 64 min. volume to add vertices to convex-hulls 0.0001 convex-hull approximation 1 OpenCL acceleration 1 OpenCL platform ID 0 OpenCL device ID 0 output output.wrl log log.txt
- param maxhulls:
Maximum number of convex hulls to return
- type maxhulls:
int
- param **kwargs:
- type **kwargs:
testVHACD keyword arguments
- returns:
meshes β List of convex meshes that approximate the original
- rtype:
list of trimesh.Trimesh
- union(other, engine=None, **kwargs)[source]#
Boolean union between this mesh and n other meshes
- Parameters:
- Returns:
union β Union of self and other Trimesh objects
- Return type:
- difference(other, engine=None, **kwargs)[source]#
Boolean difference between this mesh and n other meshes
- Parameters:
other (trimesh.Trimesh, or list of trimesh.Trimesh objects) β Meshes to difference
- Returns:
difference β Difference between self and other Trimesh objects
- Return type:
- intersection(other, engine=None, **kwargs)[source]#
Boolean intersection between this mesh and n other meshes
- Parameters:
other (trimesh.Trimesh, or list of trimesh.Trimesh objects) β Meshes to calculate intersections with
- Returns:
intersection β Mesh of the volume contained by all passed meshes
- Return type:
- contains(points)[source]#
Given an array of points determine whether or not they are inside the mesh. This raises an error if called on a non-watertight mesh.
- Parameters:
points ((n, 3) float) β Points in cartesian space
- Returns:
contains β Whether or not each point is inside the mesh
- Return type:
(n, ) bool
- property face_angles#
Returns the angle at each vertex of a face.
- Returns:
angles β Angle at each vertex of a face
- Return type:
(len(self.faces), 3) float
- property face_angles_sparse#
A sparse matrix representation of the face angles.
- Returns:
sparse β Float sparse matrix with with shape: (len(self.vertices), len(self.faces))
- Return type:
scipy.sparse.coo_matrix
- property vertex_defects#
Return the vertex defects, or (2*pi) minus the sum of the angles of every face that includes that vertex.
If a vertex is only included by coplanar triangles, this will be zero. For convex regions this is positive, and concave negative.
- Returns:
vertex_defect β Vertex defect at the every vertex
- Return type:
(len(self.vertices), ) float
- property vertex_degree#
Return the number of faces each vertex is included in.
- Returns:
degree β Number of faces each vertex is included in
- Return type:
(len(self.vertices), ) int
- property face_adjacency_tree#
An R-tree of face adjacencies.
- Returns:
tree β Where each edge in self.face_adjacency has a rectangular cell
- Return type:
rtree.index
- copy(include_cache=False)[source]#
Safely return a copy of the current mesh.
By default, copied meshes will have emptied cache to avoid memory issues and so may be slow on initial operations until caches are regenerated.
Current object will never have its cache cleared.
- Parameters:
include_cache (bool) β If True, will shallow copy cached data to new mesh
- Returns:
copied β Copy of current mesh
- Return type:
- eval_cached(statement, *args)[source]#
Evaluate a statement and cache the result before returning.
Statements are evaluated inside the Trimesh object, and
- Parameters:
statement (str) β Statement of valid python code
*args (list) β Available inside statement as args[0], etc
- Returns:
result
- Return type:
result of running eval on statement with args
Examples
r = mesh.eval_cached(βnp.dot(self.vertices, args[0])β, [0, 0, 1])
- class PointCloud[source]#
Hold 3D points in an object which can be visualized in a scene.
- __init__(vertices, colors=None, metadata=None, **kwargs)[source]#
Load an array of points into a PointCloud object.
- Parameters:
vertices ((n, 3) float) β Points in space
colors ((n, 4) uint8 or None) β RGBA colors for each point
metadata (dict or None) β Metadata about points
- property shape#
Get the shape of the pointcloud
- Returns:
shape β Shape of vertex array
- Return type:
(2,) int
- property is_empty#
Are there any vertices defined or not.
- Returns:
empty β True if no vertices defined
- Return type:
bool
- copy()[source]#
Safely get a copy of the current point cloud.
Copied objects will have emptied caches to avoid memory issues and so may be slow on initial operations until caches are regenerated.
Current object will not have its cache cleared.
- Returns:
copied β Copy of current point cloud
- Return type:
- hash()[source]#
Get a hash of the current vertices.
- Returns:
hash β Hash of self.vertices
- Return type:
str
- crc()[source]#
Get a CRC hash of the current vertices.
- Returns:
crc β Hash of self.vertices
- Return type:
int
- apply_transform(transform)[source]#
Apply a homogeneous transformation to the PointCloud object in- place.
- Parameters:
transform ((4, 4) float) β Homogeneous transformation to apply to PointCloud
- property bounds#
The axis aligned bounds of the PointCloud
- Returns:
bounds β Minimum, Maximum verteex
- Return type:
(2, 3) float
- property extents#
The size of the axis aligned bounds
- Returns:
extents β Edge length of axis aligned bounding box
- Return type:
(3,) float
- property centroid#
The mean vertex position
- Returns:
centroid β Mean vertex position
- Return type:
(3,) float
- property vertices#
Vertices of the PointCloud
- Returns:
vertices β Points in the PointCloud
- Return type:
(n, 3) float
- property colors#
Stored per- point color
- Returns:
colors β Per- point RGBA color
- Return type:
(len(self.vertices), 4) np.uint8
- property kdtree#
Return a scipy.spatial.cKDTree of the vertices of the mesh. Not cached as this lead to observed memory issues and segfaults.
- Returns:
tree β Contains mesh.vertices
- Return type:
scipy.spatial.cKDTree
- property convex_hull#
A convex hull of every point.
- Returns:
convex_hull β A watertight mesh of the hull of the points
- Return type:
- scene()[source]#
A scene containing just the PointCloud
- Returns:
scene β Scene object containing this PointCloud
- Return type:
- export(file_obj=None, file_type=None, **kwargs)[source]#
Export the current pointcloud to a file object. If file_obj is a filename, file will be written there. Supported formats are xyz :param file_obj: str, file name where to save the pointcloud
None, if you would like this function to return the export blob
- Parameters:
file_type (str) β Which file type to export as. If file name is passed this is not required
- query(input_points, **kwargs)[source]#
Find the the closest points and associated attributes from this PointCloud. :param input_points: Input query points :type input_points: (n, 3) float :param kwargs: Arguments for proximity.query_from_points :type kwargs: dict :param result: Result of the query. :type result: proximity.NearestQueryResult
- class Scene[source]#
A simple scene graph which can be rendered directly via pyglet/openGL or through other endpoints such as a raytracer. Meshes are added by name, which can then be moved by updating transform in the transform tree.
- __init__(geometry=None, base_frame='world', metadata=None, graph=None, camera=None, lights=None, camera_transform=None)[source]#
Create a new Scene object.
- Parameters:
geometry (Trimesh, Path2D, Path3D PointCloud or list) β Geometry to initially add to the scene
base_frame (str or hashable) β Name of base frame
metadata (dict) β Any metadata about the scene
graph (TransformForest or None) β A passed transform graph to use
camera (Camera or None) β A passed camera to use
lights ([trimesh.scene.lighting.Light] or None) β A passed lights to use
camera_transform ((4, 4) float or None) β Camera transform in the base frame
- apply_transform(transform)[source]#
Apply a transform to all children of the base frame without modifying any geometry.
- Parameters:
transform ((4, 4)) β Homogeneous transformation matrix.
- add_geometry(geometry, node_name=None, geom_name=None, parent_node_name=None, transform=None, extras=None)[source]#
Add a geometry to the scene.
If the mesh has multiple transforms defined in its metadata, they will all be copied into the TransformForest of the current scene automatically.
- Parameters:
geometry (Trimesh, Path2D, Path3D PointCloud or list) β Geometry to initially add to the scene
node_name (Name of the added node.) β
geom_name (Name of the added geometry.) β
parent_node_name (Name of the parent node in the graph.) β
transform (Transform that applies to the added node.) β
extras (Optional metadata for the node.) β
- Returns:
node_name β Name of single node in self.graph (passed in) or None if node was not added (eg. geometry was null or a Scene).
- Return type:
str
- delete_geometry(names)[source]#
Delete one more multiple geometries from the scene and also remove any node in the transform graph which references it.
- Parameters:
name (hashable) β Name that references self.geometry
- strip_visuals()[source]#
Strip visuals from every Trimesh geometry and set them to an empty ColorVisuals.
- __hash__()[source]#
Return information about scene which is hashable.
- Returns:
hashable β Data which can be hashed.
- Return type:
str
- property is_empty#
Does the scene have anything in it.
- Returns:
is_empty
- Return type:
bool, True if nothing is in the scene
- property is_valid#
Is every geometry connected to the root node.
- Returns:
is_valid β Does every geometry have a transform
- Return type:
bool
- property bounds_corners#
Get the post-transform AABB for each node which has geometry defined.
- Returns:
corners β
- Bounds for each node with vertices:
{node_name : (2, 3) float}
- Return type:
dict
- property bounds#
Return the overall bounding box of the scene.
- Returns:
bounds β Position of [min, max] bounding box Returns None if no valid bounds exist
- Return type:
(2, 3) float or None
- property extents#
Return the axis aligned box size of the current scene.
- Returns:
extents β Bounding box sides length
- Return type:
(3,) float
- property scale#
The approximate scale of the mesh
- Returns:
scale β The mean of the bounding box edge lengths
- Return type:
float
- property centroid#
Return the center of the bounding box for the scene.
- Returns:
centroid β Point for center of bounding box
- Return type:
float
- property center_mass#
Find the center of mass for every instance in the scene.
- Returns:
center_mass β The center of mass of the scene
- Return type:
(3,) float
- property moment_inertia#
Return the moment of inertia of the current scene with respect to the center of mass of the current scene.
- Returns:
inertia β Inertia with respect to cartesian axis at scene.center_mass
- Return type:
(3, 3) float
- moment_inertia_frame(transform)[source]#
Return the moment of inertia of the current scene relative to a transform from the base frame.
Parameters transform : (4, 4) float
Homogenous transformation matrix.
- Returns:
inertia β Inertia tensor at requested frame.
- Return type:
(3, 3) float
- property area#
What is the summed area of every geometry which has area.
- Returns:
area β Summed area of every instanced geometry
- Return type:
float
- property volume#
What is the summed volume of every geometry which has volume
- Returns:
volume β Summed area of every instanced geometry
- Return type:
float
- property triangles#
Return a correctly transformed polygon soup of the current scene.
- Returns:
triangles β Triangles in space
- Return type:
(n, 3, 3) float
- property triangles_node#
Which node of self.graph does each triangle come from.
- Returns:
triangles_index β Node name for each triangle
- Return type:
(len(self.triangles),)
- property geometry_identifiers#
Look up geometries by identifier hash
- Returns:
identifiers β {Identifier hash: key in self.geometry}
- Return type:
dict
- property duplicate_nodes#
Return a sequence of node keys of identical meshes.
Will include meshes with different geometry but identical spatial hashes as well as meshes repeated by self.nodes.
- Returns:
duplicates β Keys of self.graph that represent identical geometry
- Return type:
sequence
- deduplicated()[source]#
Return a new scene where each unique geometry is only included once and transforms are discarded.
- Returns:
dedupe β One copy of each unique geometry from scene
- Return type:
- set_camera(angles=None, distance=None, center=None, resolution=None, fov=None)[source]#
Create a camera object for self.camera, and add a transform to self.graph for it.
If arguments are not passed sane defaults will be figured out which show the mesh roughly centered.
- Parameters:
angles ((3,) float) β Initial euler angles in radians
distance (float) β Distance from centroid
center ((3,) float) β Point camera should be center on
camera (Camera object) β Object that stores camera parameters
- property camera_transform#
Get camera transform in the base frame.
- Returns:
camera_transform β Camera transform in the base frame
- Return type:
(4, 4) float
- camera_rays()[source]#
Calculate the trimesh.scene.Camera origin and ray direction vectors. Returns one ray per pixel as set in camera.resolution
- Returns:
origin ((n, 3) float) β Ray origins in space
vectors ((n, 3) float) β Ray direction unit vectors in world coordinates
pixels ((n, 2) int) β Which pixel does each ray correspond to in an image
- property camera#
Get the single camera for the scene. If not manually set one will abe automatically generated.
- Returns:
camera β Camera object defined for the scene
- Return type:
trimesh.scene.Camera
- property has_camera#
- property lights#
Get a list of the lights in the scene. If nothing is set it will generate some automatically.
- Returns:
lights β Lights in the scene.
- Return type:
[trimesh.scene.lighting.Light]
- rezero()[source]#
Move the current scene so that the AABB of the whole scene is centered at the origin.
Does this by changing the base frame to a new, offset base frame.
- subscene(node)[source]#
Get part of a scene that succeeds a specified node.
- Parameters:
node (any) β Hashable key in scene.graph
- Returns:
subscene β Partial scene generated from current.
- Return type:
- property convex_hull#
The convex hull of the whole scene
- Returns:
hull
- Return type:
Trimesh object, convex hull of all meshes in scene
- export(file_obj=None, file_type=None, **kwargs)[source]#
Export a snapshot of the current scene.
- Parameters:
file_obj (str, file-like, or None) β File object to export to
file_type (str or None) β What encoding to use for meshes IE: dict, dict64, stl
- Returns:
export β Only returned if file_obj is None
- Return type:
bytes
- save_image(resolution=None, **kwargs)[source]#
Get a PNG image of a scene.
- Parameters:
resolution ((2,) int) β Resolution to render image
**kwargs β Passed to SceneViewer constructor
- Returns:
png β Render of scene as a PNG
- Return type:
bytes
- property units#
Get the units for every model in the scene, and raise a ValueError if there are mixed units.
- Returns:
units β Units for every model in the scene
- Return type:
str
- convert_units(desired, guess=False)[source]#
If geometry has units defined convert them to new units.
Returns a new scene with geometries and transforms scaled.
- Parameters:
desired (str) β Desired final unit system: βinchesβ, βmmβ, etc.
guess (bool) β Is the converter allowed to guess scale when models donβt have it specified in their metadata.
- Returns:
scaled β Copy of scene with scaling applied and units set for every model
- Return type:
- explode(vector=None, origin=None)[source]#
Explode a scene around a point and vector.
- Parameters:
vector ((3,) float or float) β Explode radially around a direction vector or spherically
origin ((3,) float) β Point to explode around
- scaled(scale)[source]#
Return a copy of the current scene, with meshes and scene transforms scaled to the requested factor.
- Parameters:
scale (float or (3,) float) β Factor to scale meshes and transforms
- Returns:
scaled β A copy of the current scene but scaled
- Return type:
- copy()[source]#
Return a deep copy of the current scene
- Returns:
copied β Copy of the current scene
- Return type:
- show(viewer=None, **kwargs)[source]#
Display the current scene.
- Parameters:
viewer (str) β What kind of viewer to open, including βglβ to open a pyglet window, βnotebookβ for a jupyter notebook or None
kwargs (dict) β Includes smooth, which will turn on or off automatic smooth shading
- __add__(other)[source]#
Concatenate the current scene with another scene or mesh.
- Parameters:
other (trimesh.Scene, trimesh.Trimesh, trimesh.Path) β Other object to append into the result scene
- Returns:
appended β Scene with geometry from both scenes
- Return type:
- unitize(vectors, check_valid=False, threshold=None)[source]#
Unitize a vector or an array or row-vectors.
- Parameters:
vectors ((n,m) or (j) float) β Vector or vectors to be unitized
check_valid (bool) β If set, will return mask of nonzero vectors
threshold (float) β Cutoff for a value to be considered zero.
- Returns:
unit ((n,m) or (j) float) β Input vectors but unitized
valid ((n,) bool or bool) β Mask of nonzero vectors returned if check_valid
- load(file_obj, file_type=None, resolver=None, force=None, **kwargs)[source]#
Load a mesh or vectorized path into objects like Trimesh, Path2D, Path3D, Scene
- Parameters:
file_obj (str, or file- like object) β The source of the data to be loadeded
file_type (str) β What kind of file type do we have (eg: βstlβ)
resolver (trimesh.visual.Resolver) β Object to load referenced assets like materials and textures
force (None or str) β For βmeshβ: try to coerce scenes into a single mesh For βsceneβ: try to coerce everything into a scene
kwargs (dict) β Passed to geometry __init__
- Returns:
geometry β Loaded geometry as trimesh classes
- Return type:
- load_mesh(file_obj, file_type=None, resolver=None, **kwargs)[source]#
Load a mesh file into a Trimesh object
- Parameters:
file_obj (str or file object) β File name or file with mesh data
file_type (str or None) β Which file type, e.g. βstlβ
kwargs (dict) β Passed to Trimesh constructor
- Returns:
mesh β Loaded geometry data
- Return type:
- load_path(file_obj, file_type=None, **kwargs)[source]#
Load a file to a Path file_object.
- Parameters:
file_obj (One of the following:) β
Path, Path2D, or Path3D file_objects
open file file_object (dxf or svg)
file name (dxf or svg)
shapely.geometry.Polygon
shapely.geometry.MultiLineString
dict with kwargs for Path constructor
(n,2,(2|3)) float, line segments
file_type (str) β Type of file is required if file file_object passed.
- Returns:
path β Data as a native trimesh Path file_object
- Return type:
Path, Path2D, Path3D file_object
- load_remote(url, **kwargs)[source]#
Load a mesh at a remote URL into a local trimesh object.
This must be called explicitly rather than automatically from trimesh.load to ensure users donβt accidentally make network requests.
- transform_points(points, matrix, translate=True)[source]#
Returns points rotated by a homogeneous transformation matrix.
If points are (n, 2) matrix must be (3, 3) If points are (n, 3) matrix must be (4, 4)
- Parameters:
points ((n, D) float) β Points where D is 2 or 3
matrix ((3, 3) or (4, 4) float) β Homogeneous rotation matrix
translate (bool) β Apply translation from matrix or not
- Returns:
transformed β Transformed points
- Return type:
(n, d) float