Skip to main content

An invigorating blend of 3D geometry tools in Python.

Project description

potpourri3d

A Python library of various algorithms and utilities for 3D triangle meshes, polygon meshes, and point clouds. Managed by Nicholas Sharp, with new tools added lazily as needed. Currently, mainly bindings to C++ tools from geometry-central.

pip install potpourri3d

The blend includes:

  • Mesh and point cloud reading/writing to a few file formats
  • Use heat methods to compute unsigned and signed distances, parallel transport, logarithmic maps, and more
  • Computing geodesic polylines along surface via edge flips
  • More!

Installation

Potpourri3d is on the pypi package index with precompiled binaries for most configuations. Get it like:

pip install potpourri3d

If none of the precompiled binaries match your system, pip will attempt to compile the library from scratch. This requires cmake and a workng C++ compiler toolchain.

Note: Some bound functions invoke sparse linear solvers internally. The precompiled binaries use Eigen's solvers; using Suitesparse's solvers instead may significantly improve performance & robustness. To get them, locally compile the package on a machine with Suitesparse installed using the command below (relevant docs).

python -m pip install potpourri3d --no-binary potpourri3d

Documentation

Input / Output

Read/write meshes and point clouds from some common formats.

  • read_mesh(filename) Reads a mesh from file. Returns numpy matrices V, F, a Nx3 real numpy array of vertices and a Mx3 integer numpy array of 0-based face indices (or Mx4 for a quad mesh, etc).

  • read_polygon_mesh(filename) Reads a mesh from file. Returns numpy matrices V, F, where V is a Nx3 real numpy array of vertices, and a polygons is a nested list of integers; each sub-list represents a polygon face with 0-based face indices.

    • filename the path to read the file from. Currently supports the same file types as geometry-central. The file type is inferred automatically from the path extension.
  • write_mesh(V, F, filename, UV_coords=None, UV_type=None) Write a mesh to file, optionally with UV coords.

    • V a Nx3 real numpy array of vertices
    • F a Mx3 integer numpy array of faces, with 0-based vertex indices (or Mx4 for a quad mesh, etc).
    • filename the path to write the file to. Currently supports the same file types as geometry-central. The file type is inferred automatically from the path extension.
    • UV_coords (optional) a Ux2 numpy array of UV coords, interpreted based on UV_type. Warning: this function does not currently preserve shared UV indices when writing, each written coordinate is independent
    • UV_type (optional) string, one of 'per-vertex', 'per-face', or 'per-corner'. The size of U should be N, M, or M*3/4, respectively
  • read_point_cloud(filename) Reads a point cloud from file. Returns numpy matrix V, a Nx3 real numpy array of vertices. Really, this just reads a mesh file and ignores the face entries.

    • filename the path to read the file from. Currently supports the same file types as geometry-central's mesh reader. The file type is inferred automatically from the path extension.
  • write_point_cloud(V, filename) Write a mesh to file. Really, this just writes a mesh file with no face entries.

    • V a Nx3 real numpy array of vertices
    • filename the path to write the file to. Currently supports the same file types as geometry-central's mesh writer. The file type is inferred automatically from the path extension.

Mesh basic utilities

  • face_areas(V, F) computes a length-F real numpy array of face areas for a triangular mesh
  • vertex_areas(V, F) computes a length-V real numpy array of vertex areas for a triangular mesh (equal to 1/3 the sum of the incident face areas)
  • cotan_laplacian(V, F, denom_eps=0.) computes the cotan-Laplace matrix as a VxV real sparse csr scipy matrix. Optionally, set denom_eps to a small value like 1e-6 to get some additional stability in the presence of degenerate faces.
  • edges(V, F) returns the Ex2 integer-valued matrix representing the edges of the given surface mesh, as constructed internally. The i-th row gives the indices of the i-th edge's two endpoint vertices.
  • Barycentric points are used as input and output to some algorithms below, specified as 2-tuples of the form (element_index, barycentric_coordinates):
    • Vertices are specified as (vertex_index, )
    • Edges are specified as (edge_index, [t]) where t ∈ [0,1] is the parameter along the edge
    • Faces are specified as (face_index, [tA, tB]) where tA, tB (and optionally, tC) are barycentric coordinates in the face. If tC is not specified, then tC is inferred to be 1 - tA - tB.
  • MarchingTrianglesSolver(V, F) construct an instance of a solver class for contouring scalar functions on triangle meshes using the marching triangles algorithm.
    • MarchingTrianglesSolver.marching_triangles(u, isoval=0.) takes as input a vector u representing a scalar function defined on mesh vertices, and an isovalue; returns a list of lists of barycentric points, where each sublist represents a single connected curve component.
    • marching_triangles(V, F, u, isoval=0.) is similar to the above, but one-off instead of stateful. Returns a list of lists of barycentric points.

Mesh Distance

Use the heat method for geodesic distance to compute geodesic distance on surfaces. Repeated solves are fast after initial setup. Uses intrinsic triangulations internally for increased robustness.

import potpourri3d as pp3d

# = Stateful solves (much faster if computing distance many times)
solver = pp3d.MeshHeatMethodDistanceSolver(V,F)
dist = solver.compute_distance(7)
dist = solver.compute_distance_multisource([1,2,3])  

# = One-off versions
dist = pp3d.compute_distance(V,F,7)
dist = pp3d.compute_distance_multisource(V,F,[1,3,4])

The heat method works by solving a sequence of linear PDEs on the surface of your shape. On extremely coarse meshes, it may yield inaccurate results, if you observe this, consider using a finer mesh to improve accuracy. (TODO: do this internally with intrinsic Delaunay refinement.)

  • MeshHeatMethodDistanceSolver(V, F, t_coef=1., use_robust=True) construct an instance of the solver class.
    • V a Nx3 real numpy array of vertices
    • F a Mx3 integer numpy array of faces, with 0-based vertex indices (triangle meshes only, but need not be manifold).
    • t_coef set the time used for short-time heat flow. Generally don't change this. If necessary, larger values may make the solution more stable at the cost of smoothing it out.
    • use_robust use intrinsic triangulations for increased robustness. Generaly leave this enabled.
  • MeshHeatMethodDistanceSolver.compute_distance(v_ind) compute distance from a single vertex, given by zero-based index. Returns an array of distances.
  • MeshHeatMethodDistanceSolver.compute_distance_multisource(v_ind_list) compute distance from the nearest of a collection of vertices, given by a list of zero-based indices. Returns an array of distances.
  • compute_distance(V, F, v_ind) Similar to above, but one-off instead of stateful. Returns an array of distances.
  • compute_distance_multisource(V, F, v_ind_list) Similar to above, but one-off instead of stateful. Returns an array of distances.

Mesh Signed Distance

Use the signed heat method to compute signed distance on meshes, robust to holes and noise. Repeated solves are fast after initial setup.

import potpourri3d as pp3d

V, F = # your mesh
solver = pp3d.MeshSignedHeatSolver(V, F)

# Specify a curve as a sequence of barycentric points
curves = [
           [
             (61, [0.3, 0.3]), # face
             (7, []), # vertex
             (16, [0.3, 0.3, 0.4]), # face
             (11, [0.4]), # edge
             (71, []), # vertex
             (20, [0.3, 0.3, 0.4]), # face
             (13, []), # vertex
             (58, []) # vertex
             ]
         ]

# Compute a distance field combining signed distance to curve sources, and unsigned distance to point sources.
dist = solver.compute_distance(curves, [], points) 
  • MeshSignedHeatSolver.compute_distance(curves, is_signed, points, preserve_source_normals=False, level_set_constraint="ZeroSet", soft_level_set_weight=-1)
    • curves a list of lists of source points; each point is specified via barycentric coordinates.
    • is_signed a list of bools, one for each curve in curves, indicating whether one should compute signed distance (True) or unsigned distance (False) to a curve. All True by default.
    • points a list of source vertex indices
    • preserve_source_normals whether to additionally constrain the normals of the curve. Generally not necessary.
    • level_set_constraint whether to apply level set constraints, with options "ZeroSet", "None", "Multiple". Generally set to "ZeroSet" (set by default).
    • soft_level_set_weight float; if positive, gives the weight with which the given level set constraint is "softly" enforced (negative by default). Generally not necessary.

Mesh Fast Marching Distance

import potpourri3d as pp3d

V, F = # your mesh
solver = pp3d.MeshFastMarchingDistanceSolver(V, F)

# Specify each curve as a sequence of barycentric points
curves = [
           [
             (61, [0.3, 0.3]), # face
             (7, []), # vertex
             (16, [0.3, 0.3, 0.4]), # face
             (11, [0.4]), # edge
             (71, []), # vertex
             (20, [0.3, 0.3, 0.4]), # face
             (13, []), # vertex
             (58, []) # vertex
             ]
         ]

# Compute a signed distance field to a set of closed curves.
signed_dist = solver.compute_distance(curves, sign=True) 

# Compute unsigned to a set of points.
points = [
          [
            (71, []), # vertex
            (18, [0.5]) # edge
          ]
         ]
unsigned_dist = solver.compute_distance(points, sign=False) 
  • MeshFastMarchingDistanceSolver.compute_distance(curves, distances=[], sign=False)
    • curves a list of lists of source points; each point is specified via barycentric coordinates.
    • distances a list of lists of initial distances. Default initial distances are 0.
    • sign if False, compute unsigned distance; if True, compute signed distance. (When initial distances are not 0, "signed" means that the gradient of distance is continuous across the source curves.)

Mesh Vector Heat

Use the vector heat method and affine heat method to compute various interpolation & vector-based quantities on meshes. Repeated solves are fast after initial setup.

import potpourri3d as pp3d

# = Stateful solves
V, F = # a Nx3 numpy array of points and Mx3 array of triangle face indices
solver = pp3d.MeshVectorHeatSolver(V,F)

# Extend the value `0.` from vertex 12 and `1.` from vertex 17. Any vertex 
# geodesically closer to 12. will take the value 0., and vice versa 
# (plus some slight smoothing)
ext = solver.extend_scalar([12, 17], [0.,1.])

# Get the tangent frames which are used by the solver to define tangent data
# at each vertex
basisX, basisY, basisN = solver.get_tangent_frames()

# Parallel transport a vector along the surface
# (and map it to a vector in 3D)
sourceV = 22
ext = solver.transport_tangent_vector(sourceV, [6., 6.])
ext3D = ext[:,0,np.newaxis] * basisX +  ext[:,1,np.newaxis] * basisY

# Compute the logarithmic map
logmap = solver.compute_log_map(sourceV)
  • MeshVectorHeatSolver(V, F, t_coef=1., useIntrinsicDelaunay=True) construct an instance of the solver class.
    • V a Nx3 real numpy array of vertices
    • F a Mx3 integer numpy array of faces, with 0-based vertex indices (triangle meshes only, should be manifold).
    • t_coef set the time used for short-time heat flow. Generally don't change this. If necessary, larger values may make the solution more stable at the cost of smoothing it out.
    • useIntrinsicDelaunay if true, an intrinsic triangulation is used internally to improve robustness
  • MeshVectorHeatSolver.extend_scalar(v_inds, values) nearest-geodesic-neighbor interpolate values defined at vertices. Vertices will take the value from the closest source vertex (plus some slight smoothing)
    • v_inds a list of source vertices
    • values a list of scalar values, one for each source vertex
  • MeshVectorHeatSolver.get_tangent_frames() get the coordinate frames used to define tangent data at each vertex. Returned as a tuple of basis-X, basis-Y, and normal axes, each as an Nx3 array. May be necessary for change-of-basis into or out of tangent vector convention.
  • MeshVectorHeatSolver.get_connection_laplacian() get the connection Laplacian used internally in the vector heat method, as a VxV sparse matrix.
  • MeshVectorHeatSolver.transport_tangent_vector(v_ind, vector) parallel transports a single vector across a surface
    • v_ind index of the source vertex
    • vector a 2D tangent vector to transport
  • MeshVectorHeatSolver.transport_tangent_vectors(v_inds, vectors) parallel transports a collection of vectors across a surface, such that each vertex takes the vector from its nearest-geodesic-neighbor.
    • v_inds a list of source vertices
    • vectors a list of 2D tangent vectors, one for each source vertex
  • MeshVectorHeatSolver.compute_log_map(v_ind, strategy='AffineLocal') compute the logarithmic map centered at the given source vertex
    • v_ind index of the source vertex
    • strategy one of 'VectorHeat','AffineLocal', 'AffineAdaptive', see here for an explanation

Mesh Geodesic Paths

Use edge flips to compute geodesic paths on surfaces. These methods take an initial path, loop, or start & end points along the surface, and straighten the path out to be geodesic.

This approach is mainly useful when you want the path itself, rather than the distance. These routines use an iterative strategy which is quite fast, but note that it is not guaranteed to generate a globally-shortest geodesic (they sometimes find some other very short geodesic instead if straightening falls into different local minimum).

import potpourri3d as pp3d

V, F = # your mesh
path_solver = pp3d.EdgeFlipGeodesicSolver(V,F) # shares precomputation for repeated solves
path_pts = path_solver.find_geodesic_path(v_start=14, v_end=22)
# path_pts is a Vx3 numpy array of points forming the path
  • EdgeFlipGeodesicSolver(V, F) construct an instance of the solver class.
    • V a Nx3 real numpy array of vertices
    • F a Mx3 integer numpy array of faces, with 0-based vertex indices (must form a manifold, oriented triangle mesh).
  • EdgeFlipGeodesicSolver.find_geodesic_path(v_start, v_end, max_iterations=None, max_relative_length_decrease=None) compute a geodesic from v_start to v_end. Output is an Nx3 numpy array of positions which define the path as a polyline along the surface.
  • EdgeFlipGeodesicSolver.find_geodesic_path_poly(v_list, max_iterations=None, max_relative_length_decrease=None) like find_geodesic_path(), but takes as input a list of vertices [v_start, v_a, v_b, ..., v_end], which is shorted to find a path from v_start to v_end. Useful for finding geodesics which are not shortest paths. The input vertices do not need to be connected; the routine internally constructs a piecwise-Dijkstra path between them. However, that path must not cross itself.
  • EdgeFlipGeodesicSolver.find_geodesic_loop(v_list, max_iterations=None, max_relative_length_decrease=None) like find_geodesic_path_poly(), but connects the first to last point to find a closed geodesic loop.

In the functions above, the optional argument max_iterations is an integer, giving the the maximum number of shortening iterations to perform (default: no limit). The optional argument max_relative_length_decrease is a float limiting the maximum decrease in length for the path, e.g. 0.5 would mean the resulting path is at least 0.5 * L length, where L is the initial length.

Mesh Geodesic Tracing

Given an initial point and direction/length, these routines trace out a geodesic path along the surface of the mesh and return it as a polyline.

import potpourri3d as pp3d

V, F = # your mesh
tracer = pp3d.GeodesicTracer(V,F) # shares precomputation for repeated traces

trace_pts = tracer.trace_geodesic_from_vertex(22, np.array((0.3, 0.5, 0.4)))
# trace_pts is a Vx3 numpy array of points forming the path
  • GeodesicTracer(V, F) construct an instance of the tracer class.
    • V a Nx3 real numpy array of vertices
    • F a Mx3 integer numpy array of faces, with 0-based vertex indices (must form a manifold, oriented triangle mesh).
  • GeodesicTracer.trace_geodesic_from_vertex(start_vert, direction_xyz, max_iterations=None) trace a geodesic from start_vert. direction_xyz is a length-3 vector giving the direction to walk trace in 3D xyz coordinates, it will be projected onto the tangent space of the vertex. The magnitude of direction_xyz determines the distance walked. Output is an Nx3 numpy array of positions which define the path as a polyline along the surface.
  • GeodesicTracer.trace_geodesic_from_face(start_face, bary_coords, direction_xyz, max_iterations=None) similar to above, but from a point in a face. bary_coords is a length-3 vector of barycentric coordinates giving the location within the face to start from.

Set max_iterations to terminate early after tracing the path through some number of faces/edges (default: no limit).

Polygon Mesh Distance & Transport

Use the heat method for unsigned geodesic distance, the signed heat method to compute signed distance, and the vector heat method to compute various interpolation & vector-based quantities on general polygon meshes (including mixed-degree meshes, such as tri-quad meshes). Repeated solves are fast after initial setup.

import potpourri3d as pp3d

V, polygons = # your polygon mesh
solver = pp3d.PolygonMeshHeatSolver(V, F)

# Compute unsigned geodesic distance to vertices 12 and 17
dist = solver.compute_distance([12, 17])

# Extend the value `0.` from vertex 12 and `1.` from vertex 17. Any vertex 
# geodesically closer to 12. will take the value 0., and vice versa 
# (plus some slight smoothing)
ext = solver.extend_scalar([12, 17], [0.,1.])

# Get the tangent frames which are used by the solver to define tangent data
# at each vertex
basisX, basisY, basisN = solver.get_tangent_frames()

# Parallel transport a vector along the surface
# (and map it to a vector in 3D)
sourceV = 22
ext = solver.transport_tangent_vector(sourceV, [6., 6.])
ext3D = ext[:,0,np.newaxis] * basisX +  ext[:,1,np.newaxis] * basisY

# Compute signed distance to the oriented curve(s) denoted by a vertex sequence.
curves = [
           [9, 10, 12, 13, 51, 48], 
           [79, 93, 12, 30, 78, 18, 92], 
           [90, 84, 19, 91, 82, 81, 83]
         ]
signed_dist = solver.compute_signed_distance(curves)
  • PolygonMeshHeatSolver(V, polygons, t_coef=1.) construct an instance of the solver class.
    • V a Nx3 real numpy array of vertices
    • polygons a list of lists; each sub-list represents a polygon face with 0-based face indices (integers).
    • t_coef set the time used for short-time heat flow. Generally don't change this. If necessary, larger values may make the solution more stable at the cost of smoothing it out.
  • PolygonMeshHeatSolver.extend_scalar(v_inds, values) nearest-geodesic-neighbor interpolate values defined at vertices. Vertices will take the value from the closest source vertex (plus some slight smoothing)
    • v_inds a list of source vertices
    • values a list of scalar values, one for each source vertex
  • PolygonMeshHeatSolver.get_tangent_frames() get the coordinate frames used to define tangent data at each vertex. Returned as a tuple of basis-X, basis-Y, and normal axes, each as an Nx3 array. May be necessary for change-of-basis into or out of tangent vector convention.
  • PolygonMeshHeatSolver.transport_tangent_vectors(v_inds, vectors) parallel transports a collection of vectors across a surface, such that each vertex takes the vector from its nearest-geodesic-neighbor.
    • v_inds a list of source vertices
    • vectors a list of 2D tangent vectors, one for each source vertex
  • PolygonMeshHeatSolver.compute_distance(v_inds)
    • v_inds a list of source vertices
  • PolygonMeshHeatSolver.compute_signed_distance(curves, level_set_constraint="ZeroSet")
    • curves a list of lists of source vertices
    • level_set_constraint whether to apply level set constraints, with options "ZeroSet", "None", "Multiple". Generally set to "ZeroSet" (set by default).

Point Cloud Distance & Vector Heat

Use the heat method for unsigned geodesic distance, the signed heat method to compute signed distance, and the vector heat method to compute various interpolation & vector-based quantities on point clouds. Repeated solves are fast after initial setup.

point cloud vector heat examples

import potpourri3d as pp3d

# = Stateful solves
P = # a Nx3 numpy array of points
solver = pp3d.PointCloudHeatSolver(P)

# Compute the geodesic distance to point 4
dists = solver.compute_distance(4)

# Extend the value `0.` from point 12 and `1.` from point 17. Any point 
# geodesically closer to 12. will take the value 0., and vice versa 
# (plus some slight smoothing)
ext = solver.extend_scalar([12, 17], [0.,1.])

# Get the tangent frames which are used by the solver to define tangent data
# at each point
basisX, basisY, basisN = solver.get_tangent_frames()

# Parallel transport a vector along the surface
# (and map it to a vector in 3D)
sourceP = 22
ext = solver.transport_tangent_vector(sourceP, [6., 6.])
ext3D = ext[:,0,np.newaxis] * basisX +  ext[:,1,np.newaxis] * basisY

# Compute the logarithmic map
logmap = solver.compute_log_map(sourceP)

# Signed distance to the oriented curve(s) denoted by a point sequence.
curves = [
           [9, 10, 12, 13, 51, 48], 
           [79, 93, 12, 30, 78, 18, 92], 
           [90, 84, 19, 91, 82, 81, 83]
         ]
signed_dist = solver.compute_signed_distance(curves, basisN)
  • PointCloudHeatSolver(P, t_coef=1.) construct an instance of the solver class.
    • P a Nx3 real numpy array of points
    • t_coef set the time used for short-time heat flow. Generally don't change this. If necessary, larger values may make the solution more stable at the cost of smoothing it out.
  • PointCloudHeatSolver.extend_scalar(p_inds, values) nearest-geodesic-neighbor interpolate values defined at points. Points will take the value from the closest source point (plus some slight smoothing)
    • v_inds a list of source points
    • values a list of scalar values, one for each source points
  • PointCloudHeatSolver.get_tangent_frames() get the coordinate frames used to define tangent data at each point. Returned as a tuple of basis-X, basis-Y, and normal axes, each as an Nx3 array. May be necessary for change-of-basis into or out of tangent vector convention.
  • PointCloudHeatSolver.transport_tangent_vector(p_ind, vector) parallel transports a single vector across a surface
    • p_ind index of the source point
    • vector a 2D tangent vector to transport
  • PointCloudHeatSolver.transport_tangent_vectors(p_inds, vectors) parallel transports a collection of vectors across a surface, such that each vertex takes the vector from its nearest-geodesic-neighbor.
    • p_inds a list of source points
    • vectors a list of 2D tangent vectors, one for each source point
  • PointCloudHeatSolver.compute_log_map(p_ind) compute the logarithmic map centered at the given source point
    • p_ind index of the source point
  • PointCloudHeatSolver.compute_signed_distance(curves, cloud_normals, preserve_source_normals=False, level_set_constraint="ZeroSet", soft_level_set_weight=-1)
    • curves a list of lists of source point indices
    • cloud_normals a list of 3D normal vectors, one for each point in the point cloud
    • preserve_source_normals whether to additionally constrain the normals of the curve. Generally not necessary.
    • level_set_constraint whether to apply level set constraints, with options "ZeroSet", "None", "Multiple". Generally set to "ZeroSet" (set by default).
    • soft_level_set_weight float; if positive, gives the weight with which the given level set constraint is "softly" enforced (negative by default). Generally not necessary.

Other Point Cloud Routines

Local Triangulation

Construct a local triangulation of a point cloud, a surface-like set of triangles amongst the points in the cloud. This is not a nice connected/watertight mesh, instead it is a crazy soup, which is a union of sets of triangles computed independently around each point. These triangles are suitable for running many geometric algorithms on, such as approximating surface properties of the point cloud, evaluating physical and geometric energies, or building Laplace matrices. See "A Laplacian for Nonmanifold Triangle Meshes", Sharp & Crane 2020, Sec 5.7 for details.

  • PointCloudLocalTriangulation(P, with_degeneracy_heuristic=True)
    • PointCloudLocalTriangulation.get_local_triangulation() returns a [V,M,3] integer numpy array, holding indices of vertices which form the triangulation. Each [i,:,:] holds the local triangles about vertex i. M is the max number of neighbors in any local triangulation. For vertices with fewer neighbors, the trailing rows hold -1.

Project details


Download files

Download the file for your platform. If you're not sure which to choose, learn more about installing packages.

Source Distribution

potpourri3d-1.3.tar.gz (30.5 MB view details)

Uploaded Source

Built Distributions

potpourri3d-1.3-pp310-pypy310_pp73-win_amd64.whl (6.1 MB view details)

Uploaded PyPyWindows x86-64

potpourri3d-1.3-pp310-pypy310_pp73-manylinux_2_17_x86_64.manylinux2014_x86_64.whl (3.5 MB view details)

Uploaded PyPymanylinux: glibc 2.17+ x86-64

potpourri3d-1.3-pp310-pypy310_pp73-manylinux_2_17_i686.manylinux2014_i686.whl (3.7 MB view details)

Uploaded PyPymanylinux: glibc 2.17+ i686

potpourri3d-1.3-pp310-pypy310_pp73-macosx_11_0_arm64.whl (3.3 MB view details)

Uploaded PyPymacOS 11.0+ ARM64

potpourri3d-1.3-pp310-pypy310_pp73-macosx_10_15_x86_64.whl (3.7 MB view details)

Uploaded PyPymacOS 10.15+ x86-64

potpourri3d-1.3-pp39-pypy39_pp73-win_amd64.whl (6.1 MB view details)

Uploaded PyPyWindows x86-64

potpourri3d-1.3-pp39-pypy39_pp73-manylinux_2_17_x86_64.manylinux2014_x86_64.whl (3.5 MB view details)

Uploaded PyPymanylinux: glibc 2.17+ x86-64

potpourri3d-1.3-pp39-pypy39_pp73-manylinux_2_17_i686.manylinux2014_i686.whl (3.7 MB view details)

Uploaded PyPymanylinux: glibc 2.17+ i686

potpourri3d-1.3-pp39-pypy39_pp73-macosx_11_0_arm64.whl (3.3 MB view details)

Uploaded PyPymacOS 11.0+ ARM64

potpourri3d-1.3-pp39-pypy39_pp73-macosx_10_15_x86_64.whl (3.7 MB view details)

Uploaded PyPymacOS 10.15+ x86-64

potpourri3d-1.3-pp38-pypy38_pp73-win_amd64.whl (6.1 MB view details)

Uploaded PyPyWindows x86-64

potpourri3d-1.3-pp38-pypy38_pp73-manylinux_2_17_x86_64.manylinux2014_x86_64.whl (3.5 MB view details)

Uploaded PyPymanylinux: glibc 2.17+ x86-64

potpourri3d-1.3-pp38-pypy38_pp73-manylinux_2_17_i686.manylinux2014_i686.whl (3.7 MB view details)

Uploaded PyPymanylinux: glibc 2.17+ i686

potpourri3d-1.3-pp38-pypy38_pp73-macosx_11_0_arm64.whl (3.3 MB view details)

Uploaded PyPymacOS 11.0+ ARM64

potpourri3d-1.3-pp38-pypy38_pp73-macosx_10_9_x86_64.whl (3.7 MB view details)

Uploaded PyPymacOS 10.9+ x86-64

potpourri3d-1.3-pp37-pypy37_pp73-win_amd64.whl (6.1 MB view details)

Uploaded PyPyWindows x86-64

potpourri3d-1.3-pp37-pypy37_pp73-manylinux_2_17_x86_64.manylinux2014_x86_64.whl (3.5 MB view details)

Uploaded PyPymanylinux: glibc 2.17+ x86-64

potpourri3d-1.3-pp37-pypy37_pp73-manylinux_2_17_i686.manylinux2014_i686.whl (3.7 MB view details)

Uploaded PyPymanylinux: glibc 2.17+ i686

potpourri3d-1.3-pp37-pypy37_pp73-macosx_10_9_x86_64.whl (3.7 MB view details)

Uploaded PyPymacOS 10.9+ x86-64

potpourri3d-1.3-cp313-cp313-win_amd64.whl (6.1 MB view details)

Uploaded CPython 3.13Windows x86-64

potpourri3d-1.3-cp313-cp313-win32.whl (4.5 MB view details)

Uploaded CPython 3.13Windows x86

potpourri3d-1.3-cp313-cp313-musllinux_1_2_x86_64.whl (4.6 MB view details)

Uploaded CPython 3.13musllinux: musl 1.2+ x86-64

potpourri3d-1.3-cp313-cp313-musllinux_1_2_i686.whl (4.9 MB view details)

Uploaded CPython 3.13musllinux: musl 1.2+ i686

potpourri3d-1.3-cp313-cp313-manylinux_2_17_x86_64.manylinux2014_x86_64.whl (3.5 MB view details)

Uploaded CPython 3.13manylinux: glibc 2.17+ x86-64

potpourri3d-1.3-cp313-cp313-manylinux_2_17_i686.manylinux2014_i686.whl (3.7 MB view details)

Uploaded CPython 3.13manylinux: glibc 2.17+ i686

potpourri3d-1.3-cp313-cp313-macosx_11_0_arm64.whl (3.3 MB view details)

Uploaded CPython 3.13macOS 11.0+ ARM64

potpourri3d-1.3-cp313-cp313-macosx_10_13_x86_64.whl (3.7 MB view details)

Uploaded CPython 3.13macOS 10.13+ x86-64

potpourri3d-1.3-cp312-cp312-win_amd64.whl (6.1 MB view details)

Uploaded CPython 3.12Windows x86-64

potpourri3d-1.3-cp312-cp312-win32.whl (4.5 MB view details)

Uploaded CPython 3.12Windows x86

potpourri3d-1.3-cp312-cp312-musllinux_1_2_x86_64.whl (4.6 MB view details)

Uploaded CPython 3.12musllinux: musl 1.2+ x86-64

potpourri3d-1.3-cp312-cp312-musllinux_1_2_i686.whl (4.9 MB view details)

Uploaded CPython 3.12musllinux: musl 1.2+ i686

potpourri3d-1.3-cp312-cp312-manylinux_2_17_x86_64.manylinux2014_x86_64.whl (3.5 MB view details)

Uploaded CPython 3.12manylinux: glibc 2.17+ x86-64

potpourri3d-1.3-cp312-cp312-manylinux_2_17_i686.manylinux2014_i686.whl (3.7 MB view details)

Uploaded CPython 3.12manylinux: glibc 2.17+ i686

potpourri3d-1.3-cp312-cp312-macosx_11_0_arm64.whl (3.3 MB view details)

Uploaded CPython 3.12macOS 11.0+ ARM64

potpourri3d-1.3-cp312-cp312-macosx_10_13_x86_64.whl (3.7 MB view details)

Uploaded CPython 3.12macOS 10.13+ x86-64

potpourri3d-1.3-cp311-cp311-win_amd64.whl (6.1 MB view details)

Uploaded CPython 3.11Windows x86-64

potpourri3d-1.3-cp311-cp311-win32.whl (4.5 MB view details)

Uploaded CPython 3.11Windows x86

potpourri3d-1.3-cp311-cp311-musllinux_1_2_x86_64.whl (4.6 MB view details)

Uploaded CPython 3.11musllinux: musl 1.2+ x86-64

potpourri3d-1.3-cp311-cp311-musllinux_1_2_i686.whl (4.9 MB view details)

Uploaded CPython 3.11musllinux: musl 1.2+ i686

potpourri3d-1.3-cp311-cp311-manylinux_2_17_x86_64.manylinux2014_x86_64.whl (3.5 MB view details)

Uploaded CPython 3.11manylinux: glibc 2.17+ x86-64

potpourri3d-1.3-cp311-cp311-manylinux_2_17_i686.manylinux2014_i686.whl (3.7 MB view details)

Uploaded CPython 3.11manylinux: glibc 2.17+ i686

potpourri3d-1.3-cp311-cp311-macosx_11_0_arm64.whl (3.3 MB view details)

Uploaded CPython 3.11macOS 11.0+ ARM64

potpourri3d-1.3-cp311-cp311-macosx_10_9_x86_64.whl (3.7 MB view details)

Uploaded CPython 3.11macOS 10.9+ x86-64

potpourri3d-1.3-cp310-cp310-win_amd64.whl (6.1 MB view details)

Uploaded CPython 3.10Windows x86-64

potpourri3d-1.3-cp310-cp310-win32.whl (4.5 MB view details)

Uploaded CPython 3.10Windows x86

potpourri3d-1.3-cp310-cp310-musllinux_1_2_x86_64.whl (4.6 MB view details)

Uploaded CPython 3.10musllinux: musl 1.2+ x86-64

potpourri3d-1.3-cp310-cp310-musllinux_1_2_i686.whl (4.9 MB view details)

Uploaded CPython 3.10musllinux: musl 1.2+ i686

potpourri3d-1.3-cp310-cp310-manylinux_2_17_x86_64.manylinux2014_x86_64.whl (3.5 MB view details)

Uploaded CPython 3.10manylinux: glibc 2.17+ x86-64

potpourri3d-1.3-cp310-cp310-manylinux_2_17_i686.manylinux2014_i686.whl (3.7 MB view details)

Uploaded CPython 3.10manylinux: glibc 2.17+ i686

potpourri3d-1.3-cp310-cp310-macosx_11_0_arm64.whl (3.3 MB view details)

Uploaded CPython 3.10macOS 11.0+ ARM64

potpourri3d-1.3-cp310-cp310-macosx_10_9_x86_64.whl (3.7 MB view details)

Uploaded CPython 3.10macOS 10.9+ x86-64

potpourri3d-1.3-cp39-cp39-win_amd64.whl (6.1 MB view details)

Uploaded CPython 3.9Windows x86-64

potpourri3d-1.3-cp39-cp39-win32.whl (4.5 MB view details)

Uploaded CPython 3.9Windows x86

potpourri3d-1.3-cp39-cp39-musllinux_1_2_x86_64.whl (4.6 MB view details)

Uploaded CPython 3.9musllinux: musl 1.2+ x86-64

potpourri3d-1.3-cp39-cp39-musllinux_1_2_i686.whl (4.9 MB view details)

Uploaded CPython 3.9musllinux: musl 1.2+ i686

potpourri3d-1.3-cp39-cp39-manylinux_2_17_x86_64.manylinux2014_x86_64.whl (3.5 MB view details)

Uploaded CPython 3.9manylinux: glibc 2.17+ x86-64

potpourri3d-1.3-cp39-cp39-manylinux_2_17_i686.manylinux2014_i686.whl (3.7 MB view details)

Uploaded CPython 3.9manylinux: glibc 2.17+ i686

potpourri3d-1.3-cp39-cp39-macosx_11_0_arm64.whl (3.3 MB view details)

Uploaded CPython 3.9macOS 11.0+ ARM64

potpourri3d-1.3-cp39-cp39-macosx_10_9_x86_64.whl (3.7 MB view details)

Uploaded CPython 3.9macOS 10.9+ x86-64

potpourri3d-1.3-cp38-cp38-win_amd64.whl (6.1 MB view details)

Uploaded CPython 3.8Windows x86-64

potpourri3d-1.3-cp38-cp38-win32.whl (4.4 MB view details)

Uploaded CPython 3.8Windows x86

potpourri3d-1.3-cp38-cp38-musllinux_1_2_x86_64.whl (4.6 MB view details)

Uploaded CPython 3.8musllinux: musl 1.2+ x86-64

potpourri3d-1.3-cp38-cp38-musllinux_1_2_i686.whl (4.9 MB view details)

Uploaded CPython 3.8musllinux: musl 1.2+ i686

potpourri3d-1.3-cp38-cp38-manylinux_2_17_x86_64.manylinux2014_x86_64.whl (3.5 MB view details)

Uploaded CPython 3.8manylinux: glibc 2.17+ x86-64

potpourri3d-1.3-cp38-cp38-manylinux_2_17_i686.manylinux2014_i686.whl (3.7 MB view details)

Uploaded CPython 3.8manylinux: glibc 2.17+ i686

potpourri3d-1.3-cp38-cp38-macosx_11_0_arm64.whl (3.3 MB view details)

Uploaded CPython 3.8macOS 11.0+ ARM64

potpourri3d-1.3-cp38-cp38-macosx_10_9_x86_64.whl (3.7 MB view details)

Uploaded CPython 3.8macOS 10.9+ x86-64

potpourri3d-1.3-cp37-cp37m-win_amd64.whl (6.1 MB view details)

Uploaded CPython 3.7mWindows x86-64

potpourri3d-1.3-cp37-cp37m-win32.whl (4.5 MB view details)

Uploaded CPython 3.7mWindows x86

potpourri3d-1.3-cp37-cp37m-musllinux_1_2_x86_64.whl (4.6 MB view details)

Uploaded CPython 3.7mmusllinux: musl 1.2+ x86-64

potpourri3d-1.3-cp37-cp37m-musllinux_1_2_i686.whl (4.9 MB view details)

Uploaded CPython 3.7mmusllinux: musl 1.2+ i686

potpourri3d-1.3-cp37-cp37m-manylinux_2_17_x86_64.manylinux2014_x86_64.whl (3.5 MB view details)

Uploaded CPython 3.7mmanylinux: glibc 2.17+ x86-64

potpourri3d-1.3-cp37-cp37m-manylinux_2_17_i686.manylinux2014_i686.whl (3.7 MB view details)

Uploaded CPython 3.7mmanylinux: glibc 2.17+ i686

potpourri3d-1.3-cp37-cp37m-macosx_10_9_x86_64.whl (3.7 MB view details)

Uploaded CPython 3.7mmacOS 10.9+ x86-64

File details

Details for the file potpourri3d-1.3.tar.gz.

File metadata

  • Download URL: potpourri3d-1.3.tar.gz
  • Upload date:
  • Size: 30.5 MB
  • Tags: Source
  • Uploaded using Trusted Publishing? Yes
  • Uploaded via: twine/6.1.0 CPython/3.12.9

File hashes

Hashes for potpourri3d-1.3.tar.gz
Algorithm Hash digest
SHA256 5a8d3578ea1013fbb990520297acb7afd25c2231870537757541980b6cea3a5e
MD5 212a08811c1f3b333dd014c318fd01f3
BLAKE2b-256 b0f852b8973fef56c0a0f725d4d9734a1cfa8596bc3c105c22368be97deb0b05

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3.tar.gz:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-pp310-pypy310_pp73-win_amd64.whl.

File metadata

File hashes

Hashes for potpourri3d-1.3-pp310-pypy310_pp73-win_amd64.whl
Algorithm Hash digest
SHA256 33755ad38ce8d2edbb9ee9ac5157efe7e45d4f400beed93ca513e49bfb1a7c28
MD5 23b86c228a05aecd1bc5b7f83ca2dcbd
BLAKE2b-256 891385d248a5613fcd6ab39cae7ce631fbaa946dba34886bfc37645baf714656

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-pp310-pypy310_pp73-win_amd64.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-pp310-pypy310_pp73-manylinux_2_17_x86_64.manylinux2014_x86_64.whl.

File metadata

File hashes

Hashes for potpourri3d-1.3-pp310-pypy310_pp73-manylinux_2_17_x86_64.manylinux2014_x86_64.whl
Algorithm Hash digest
SHA256 0f9a52b7b8e85847fc597e34f9767ea91ec4600be326af70759288cec61fbce4
MD5 1bc6caa1767c69da82831790ede69acb
BLAKE2b-256 21d3a6242c2a50c5226616fce1137f95781761071a331a67d524b6e94ea08227

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-pp310-pypy310_pp73-manylinux_2_17_x86_64.manylinux2014_x86_64.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-pp310-pypy310_pp73-manylinux_2_17_i686.manylinux2014_i686.whl.

File metadata

File hashes

Hashes for potpourri3d-1.3-pp310-pypy310_pp73-manylinux_2_17_i686.manylinux2014_i686.whl
Algorithm Hash digest
SHA256 1cbf3c5831be6dbad375b6eb420fc809b3b4e3b401b432556301efc131a5ffa3
MD5 2c755655370252b069c85454d9158412
BLAKE2b-256 2b3563dbc7825402239413a624a14fe0e29cd54952b4749420af29367f9ac2a3

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-pp310-pypy310_pp73-manylinux_2_17_i686.manylinux2014_i686.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-pp310-pypy310_pp73-macosx_11_0_arm64.whl.

File metadata

File hashes

Hashes for potpourri3d-1.3-pp310-pypy310_pp73-macosx_11_0_arm64.whl
Algorithm Hash digest
SHA256 bd9f9c7b86e6ab5d76595bef811b77fb2ded21825183c245b4de1e87d55ff1b8
MD5 ab16972fc129e6b43f1a97239730537f
BLAKE2b-256 362260f022ac2b7d88a546b92a08d47a93c0f67de2b3ea7f141e08f9ca75df44

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-pp310-pypy310_pp73-macosx_11_0_arm64.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-pp310-pypy310_pp73-macosx_10_15_x86_64.whl.

File metadata

File hashes

Hashes for potpourri3d-1.3-pp310-pypy310_pp73-macosx_10_15_x86_64.whl
Algorithm Hash digest
SHA256 fc7a22812536cd4deb9b307712593c2057a5066319e889ee9ac45f67bb110081
MD5 14ef2db37ad010516fd4548ddfff5626
BLAKE2b-256 8bf1d6d71a6b6fa243d119d7ae2cd48483b3f43c551eb753a64ae16345952ac5

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-pp310-pypy310_pp73-macosx_10_15_x86_64.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-pp39-pypy39_pp73-win_amd64.whl.

File metadata

File hashes

Hashes for potpourri3d-1.3-pp39-pypy39_pp73-win_amd64.whl
Algorithm Hash digest
SHA256 e4073e367323a0c46b7ab198de9f2ac6c24c6d5ad7fb0cd8fe5058a072006d26
MD5 92b2e747dd4e676671da398463959417
BLAKE2b-256 387abd24cec2abf8055895f36c02082a899ff5ff6dc0e007640fb4568be8f022

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-pp39-pypy39_pp73-win_amd64.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-pp39-pypy39_pp73-manylinux_2_17_x86_64.manylinux2014_x86_64.whl.

File metadata

File hashes

Hashes for potpourri3d-1.3-pp39-pypy39_pp73-manylinux_2_17_x86_64.manylinux2014_x86_64.whl
Algorithm Hash digest
SHA256 3107b7782475ab7a99c617acde753378c907531fa2466148b0cde93172473405
MD5 d3cdf9b2a1c2ed1e3aff07a60cb4ba75
BLAKE2b-256 f084454153854e6518e9b0ecfa2b633a54c2bffd2039068999aef3c6fc3ce141

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-pp39-pypy39_pp73-manylinux_2_17_x86_64.manylinux2014_x86_64.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-pp39-pypy39_pp73-manylinux_2_17_i686.manylinux2014_i686.whl.

File metadata

File hashes

Hashes for potpourri3d-1.3-pp39-pypy39_pp73-manylinux_2_17_i686.manylinux2014_i686.whl
Algorithm Hash digest
SHA256 852cce5c68f0a7928f39a5f512454b422e50d78fdfa04c18d82a4f410b2ca547
MD5 9981912eca9b156f593cb4f64908e821
BLAKE2b-256 7e968a258b4e3d042e70138d1f78e54f87b9e12f8497eea536233ac57351f642

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-pp39-pypy39_pp73-manylinux_2_17_i686.manylinux2014_i686.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-pp39-pypy39_pp73-macosx_11_0_arm64.whl.

File metadata

File hashes

Hashes for potpourri3d-1.3-pp39-pypy39_pp73-macosx_11_0_arm64.whl
Algorithm Hash digest
SHA256 53e66c5ac389fd53b4b4f08d0cf4b5fd1da21bfabcde7e1fdca24e7d9d0658d8
MD5 1b37c535da6f8d2cfc6235758a45622e
BLAKE2b-256 d67a0f53a637542725409b06f6839187e46bd5ca7c9e54954d37a4296b9f9486

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-pp39-pypy39_pp73-macosx_11_0_arm64.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-pp39-pypy39_pp73-macosx_10_15_x86_64.whl.

File metadata

File hashes

Hashes for potpourri3d-1.3-pp39-pypy39_pp73-macosx_10_15_x86_64.whl
Algorithm Hash digest
SHA256 ea6ecf330d307e69c4ee77eac79350fd30a0d6ebb473b89bcc723d90c4b8628b
MD5 f0bbb37bd8ed2558589b4157b5ef8687
BLAKE2b-256 d52670aeacb66cde40efee45966aeb16dd01b422690084928bdfb3eaaef45cde

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-pp39-pypy39_pp73-macosx_10_15_x86_64.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-pp38-pypy38_pp73-win_amd64.whl.

File metadata

File hashes

Hashes for potpourri3d-1.3-pp38-pypy38_pp73-win_amd64.whl
Algorithm Hash digest
SHA256 613abea9af7a652a852bf6bcfb7f7fba0290b8cef389ecc661eff5424670b414
MD5 f1c1874b1e86a7f8826863ccba70617a
BLAKE2b-256 acd13ce9b66e702e81da23f1341a8a02e03ccb3cc3ead1600b92418a8be7e16f

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-pp38-pypy38_pp73-win_amd64.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-pp38-pypy38_pp73-manylinux_2_17_x86_64.manylinux2014_x86_64.whl.

File metadata

File hashes

Hashes for potpourri3d-1.3-pp38-pypy38_pp73-manylinux_2_17_x86_64.manylinux2014_x86_64.whl
Algorithm Hash digest
SHA256 6bd2c482ab5d14447f7ee59b98396e8697a836610386d1c23f38e1812d987c28
MD5 f1de4332c1d99d93eef864d071c70b2c
BLAKE2b-256 9cff37b7a584c78aa1539d799dd92136b2d0c7eece84e16b9d4efdc52a358602

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-pp38-pypy38_pp73-manylinux_2_17_x86_64.manylinux2014_x86_64.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-pp38-pypy38_pp73-manylinux_2_17_i686.manylinux2014_i686.whl.

File metadata

File hashes

Hashes for potpourri3d-1.3-pp38-pypy38_pp73-manylinux_2_17_i686.manylinux2014_i686.whl
Algorithm Hash digest
SHA256 27c3c0abf832cd267614e22321ba40511ec167c70e0f47af814a49b914bfdcac
MD5 18b869f61b96a36237fc2b8ee7b33993
BLAKE2b-256 62459a270607b3443dc78e109aed0c64a6f584777a086ca9837a22b61cbbe897

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-pp38-pypy38_pp73-manylinux_2_17_i686.manylinux2014_i686.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-pp38-pypy38_pp73-macosx_11_0_arm64.whl.

File metadata

File hashes

Hashes for potpourri3d-1.3-pp38-pypy38_pp73-macosx_11_0_arm64.whl
Algorithm Hash digest
SHA256 14b077be9e266985cc426d4d23f6495bd3555feae3e20a5af9c1f03b94719b43
MD5 7d8cac82e90fdb0caf653c314bb6b4d5
BLAKE2b-256 a8f51a4dd9d61797d0a8c7eba64149b9b31bd642f6ea75441aff319b4e7a7086

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-pp38-pypy38_pp73-macosx_11_0_arm64.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-pp38-pypy38_pp73-macosx_10_9_x86_64.whl.

File metadata

File hashes

Hashes for potpourri3d-1.3-pp38-pypy38_pp73-macosx_10_9_x86_64.whl
Algorithm Hash digest
SHA256 d1835802027a61a255719f75b76671840682f750939afb59c1bc825a4ae0df49
MD5 c80d73464259a5f9c42f4323b8d434db
BLAKE2b-256 be7d75c63d91a986acdd0dd269bbcf05d001ea2ec2568bda4fa985f7b2a80c4f

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-pp38-pypy38_pp73-macosx_10_9_x86_64.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-pp37-pypy37_pp73-win_amd64.whl.

File metadata

File hashes

Hashes for potpourri3d-1.3-pp37-pypy37_pp73-win_amd64.whl
Algorithm Hash digest
SHA256 65778410201a012c661115c10134e8c42286652460e8a35f9b020c2e5ca4df0f
MD5 45464450de2df71f608b316fa238fc86
BLAKE2b-256 a2e31a9f00d5d7b504cc45c5f2e654eb59aa706225e2e69c8307988efdaf0238

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-pp37-pypy37_pp73-win_amd64.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-pp37-pypy37_pp73-manylinux_2_17_x86_64.manylinux2014_x86_64.whl.

File metadata

File hashes

Hashes for potpourri3d-1.3-pp37-pypy37_pp73-manylinux_2_17_x86_64.manylinux2014_x86_64.whl
Algorithm Hash digest
SHA256 0273b4f505adf555dc77b5794d7102fa9d7eb5414abab8b8466db34fc3b8aa30
MD5 ed720e967385fca3ded8bf8aaf462c08
BLAKE2b-256 04e1a91c529d01f2a8b575422da9d67b64a91976f551d17c31b078045e1225b6

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-pp37-pypy37_pp73-manylinux_2_17_x86_64.manylinux2014_x86_64.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-pp37-pypy37_pp73-manylinux_2_17_i686.manylinux2014_i686.whl.

File metadata

File hashes

Hashes for potpourri3d-1.3-pp37-pypy37_pp73-manylinux_2_17_i686.manylinux2014_i686.whl
Algorithm Hash digest
SHA256 f81aa4fac7c6dbcfb81778cda0ede8e05112c134eb06f2101a61b724a4bf1ffe
MD5 57ecb7593d839dcb798bea4d85463be0
BLAKE2b-256 46206f853a25e43205d1dc282a212380a07417cb35ece896a1560201183f4107

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-pp37-pypy37_pp73-manylinux_2_17_i686.manylinux2014_i686.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-pp37-pypy37_pp73-macosx_10_9_x86_64.whl.

File metadata

File hashes

Hashes for potpourri3d-1.3-pp37-pypy37_pp73-macosx_10_9_x86_64.whl
Algorithm Hash digest
SHA256 cfef3877bfd136a7f52542d547d01342104908477442d5640ba281e577e16f5c
MD5 9ec19acc40be176f7ff9a14ce94321a7
BLAKE2b-256 88e2417c4188944bb617cd8a4facf76b99b031597be5ba8f34263c3dd3da91dc

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-pp37-pypy37_pp73-macosx_10_9_x86_64.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-cp313-cp313-win_amd64.whl.

File metadata

  • Download URL: potpourri3d-1.3-cp313-cp313-win_amd64.whl
  • Upload date:
  • Size: 6.1 MB
  • Tags: CPython 3.13, Windows x86-64
  • Uploaded using Trusted Publishing? Yes
  • Uploaded via: twine/6.1.0 CPython/3.12.9

File hashes

Hashes for potpourri3d-1.3-cp313-cp313-win_amd64.whl
Algorithm Hash digest
SHA256 f7eafd4270c9a65439120e39f626ba82d2a770e93c49af96297e7fa29c10200c
MD5 322a20cb1f8adf062278f0ed4a8767c8
BLAKE2b-256 391861f85875356fdac2b213db9adcce2aa2380fcfb7d03c11334a4bb9c8b473

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-cp313-cp313-win_amd64.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-cp313-cp313-win32.whl.

File metadata

  • Download URL: potpourri3d-1.3-cp313-cp313-win32.whl
  • Upload date:
  • Size: 4.5 MB
  • Tags: CPython 3.13, Windows x86
  • Uploaded using Trusted Publishing? Yes
  • Uploaded via: twine/6.1.0 CPython/3.12.9

File hashes

Hashes for potpourri3d-1.3-cp313-cp313-win32.whl
Algorithm Hash digest
SHA256 745e05a80309d5fc053316fbb662e46bac925e2a095792af5159f488279edac3
MD5 b1da913ca9fa9c2f560b6d52b70534ed
BLAKE2b-256 d38171ae8674a00a7ce3178d5fb68f3af449d3decafa600c37ecf202ba49c233

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-cp313-cp313-win32.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-cp313-cp313-musllinux_1_2_x86_64.whl.

File metadata

File hashes

Hashes for potpourri3d-1.3-cp313-cp313-musllinux_1_2_x86_64.whl
Algorithm Hash digest
SHA256 3e1d8fed8654a6b054d07265bf499b9da756912d2f8f1d720e62a94aaacf1f38
MD5 c25f73bdfe7070c0f76752ca4c6680c5
BLAKE2b-256 58a259d8fb65b9b7b3d3c497cf924ab3914a6376b5646d4d6b83f2aac925ebdd

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-cp313-cp313-musllinux_1_2_x86_64.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-cp313-cp313-musllinux_1_2_i686.whl.

File metadata

File hashes

Hashes for potpourri3d-1.3-cp313-cp313-musllinux_1_2_i686.whl
Algorithm Hash digest
SHA256 abe9fa4552525ef73383cb9c919d28ce8c8aeef23c94b0a18dd946cb9e59ed3a
MD5 87a802ed7fa4bc405949ef60e344bf02
BLAKE2b-256 84e9ec4984b209600b9af856638fa647ab487b6b893eb36313c2b57b69f839ba

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-cp313-cp313-musllinux_1_2_i686.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-cp313-cp313-manylinux_2_17_x86_64.manylinux2014_x86_64.whl.

File metadata

File hashes

Hashes for potpourri3d-1.3-cp313-cp313-manylinux_2_17_x86_64.manylinux2014_x86_64.whl
Algorithm Hash digest
SHA256 50296cd3f2897d7b63d3f639379f1b7bf0c092242cabe94178df6747aa0d2d8c
MD5 8a3bdeca52e5ebf9ce9c606815f7c073
BLAKE2b-256 50b7dce291a0172e58cfd219aab80f2d4650d342418e3d68292cb20221bcad78

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-cp313-cp313-manylinux_2_17_x86_64.manylinux2014_x86_64.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-cp313-cp313-manylinux_2_17_i686.manylinux2014_i686.whl.

File metadata

File hashes

Hashes for potpourri3d-1.3-cp313-cp313-manylinux_2_17_i686.manylinux2014_i686.whl
Algorithm Hash digest
SHA256 add7f889b08dd47a7a1bc6d27221ca0ff836f01fb90e41c421a22f1984cc0574
MD5 30764bc37cc3d1f149ffbd4800386aab
BLAKE2b-256 deb4f2f8cc6af9520292b8018a917c6b71e7c269abf4af72c73550df81c78803

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-cp313-cp313-manylinux_2_17_i686.manylinux2014_i686.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-cp313-cp313-macosx_11_0_arm64.whl.

File metadata

File hashes

Hashes for potpourri3d-1.3-cp313-cp313-macosx_11_0_arm64.whl
Algorithm Hash digest
SHA256 43f23c908d8aa6f82a2f00d43a9e4ff0af9d3d357402f672bcef4174d4b537bf
MD5 1244882557f89ef1962f6d68630f07a5
BLAKE2b-256 8f391dafc02cc51896fee15b2a1ed9dab474531dfaf2b7d37d4282583b123965

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-cp313-cp313-macosx_11_0_arm64.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-cp313-cp313-macosx_10_13_x86_64.whl.

File metadata

File hashes

Hashes for potpourri3d-1.3-cp313-cp313-macosx_10_13_x86_64.whl
Algorithm Hash digest
SHA256 d6f03c83a9843984e602ccd4f7ca6ba41c2f8ca003adf9142207efce8f11610d
MD5 aa93a446db8052d1d97ec032f56eed13
BLAKE2b-256 041ec70dfd006395ca34170373e32535d7fc7e9b493ac53b2cbecf8ebb501538

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-cp313-cp313-macosx_10_13_x86_64.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-cp312-cp312-win_amd64.whl.

File metadata

  • Download URL: potpourri3d-1.3-cp312-cp312-win_amd64.whl
  • Upload date:
  • Size: 6.1 MB
  • Tags: CPython 3.12, Windows x86-64
  • Uploaded using Trusted Publishing? Yes
  • Uploaded via: twine/6.1.0 CPython/3.12.9

File hashes

Hashes for potpourri3d-1.3-cp312-cp312-win_amd64.whl
Algorithm Hash digest
SHA256 34aa1280f527b436a047fb42ea8c74fb597e5a314bcb1b11204cac5babd8dce7
MD5 62ab70eb0a2efe01a90a5b2bb14e597f
BLAKE2b-256 7e47685eafc91a5242c30f82c752b51b44aa7b2d8e199db2d8e357b4bc87326d

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-cp312-cp312-win_amd64.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-cp312-cp312-win32.whl.

File metadata

  • Download URL: potpourri3d-1.3-cp312-cp312-win32.whl
  • Upload date:
  • Size: 4.5 MB
  • Tags: CPython 3.12, Windows x86
  • Uploaded using Trusted Publishing? Yes
  • Uploaded via: twine/6.1.0 CPython/3.12.9

File hashes

Hashes for potpourri3d-1.3-cp312-cp312-win32.whl
Algorithm Hash digest
SHA256 c5cb3b753c2a786ae2be95ae498b49ef999465621507390b55ebec33749570a5
MD5 7912afbc5dc3882a3eab95a1a7f5c7e1
BLAKE2b-256 8ac821179725ddfb794477eaa990b4fe8121b316053cea123f7b7e71a83e6bc0

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-cp312-cp312-win32.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-cp312-cp312-musllinux_1_2_x86_64.whl.

File metadata

File hashes

Hashes for potpourri3d-1.3-cp312-cp312-musllinux_1_2_x86_64.whl
Algorithm Hash digest
SHA256 f1aa84ec7efd514450d45dcb9ced2ff427f88cccabf844a46724a6b84a3430a1
MD5 d5cbe55ddb10c6c80d57a3c4a0acd07e
BLAKE2b-256 7588a144db85192b82be5563eefdf07ca5f5072a006124051d78febea1607ecd

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-cp312-cp312-musllinux_1_2_x86_64.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-cp312-cp312-musllinux_1_2_i686.whl.

File metadata

File hashes

Hashes for potpourri3d-1.3-cp312-cp312-musllinux_1_2_i686.whl
Algorithm Hash digest
SHA256 2305d6268dd648a0f2211ea0debf6bdf46e3c26d9b6cc57b95e1c6c98f686c85
MD5 bb6208596538e4f3a3ea40eb3024e94e
BLAKE2b-256 90010cb5ef4b5459388861ff377de52e64fbf0e12de16037e7580916fc63f2f6

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-cp312-cp312-musllinux_1_2_i686.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-cp312-cp312-manylinux_2_17_x86_64.manylinux2014_x86_64.whl.

File metadata

File hashes

Hashes for potpourri3d-1.3-cp312-cp312-manylinux_2_17_x86_64.manylinux2014_x86_64.whl
Algorithm Hash digest
SHA256 e6a8c59294fb357ff88474c8191f60bb04e2c2fbffcf407499297d8c1d23a192
MD5 e5018cd19575602d1d5457072f7fb3f7
BLAKE2b-256 79fe7949083d98f8c8382c84eba53761db71124f94f19d0edc25779325849332

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-cp312-cp312-manylinux_2_17_x86_64.manylinux2014_x86_64.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-cp312-cp312-manylinux_2_17_i686.manylinux2014_i686.whl.

File metadata

File hashes

Hashes for potpourri3d-1.3-cp312-cp312-manylinux_2_17_i686.manylinux2014_i686.whl
Algorithm Hash digest
SHA256 ebe3d1976a1926d0c12b91f35c048c893fd8722f4d7a6ab9cc2f2cb678b5129f
MD5 ae8aad876e35434383c09e88efb3480a
BLAKE2b-256 53b6bb772fbb05f919c18e1673739fe52e1d020e7cbcab1e7062d3888b031478

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-cp312-cp312-manylinux_2_17_i686.manylinux2014_i686.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-cp312-cp312-macosx_11_0_arm64.whl.

File metadata

File hashes

Hashes for potpourri3d-1.3-cp312-cp312-macosx_11_0_arm64.whl
Algorithm Hash digest
SHA256 a8c72e02d8e3f88c40309333cef5e4e14f6b9194ced112474c2f545698d543ab
MD5 6b82b0f33ca4a4c0646813a65416e881
BLAKE2b-256 925baf66ee208ba07ca13765dbebf42cb4144ceac4d997493c364a5fbb71e3db

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-cp312-cp312-macosx_11_0_arm64.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-cp312-cp312-macosx_10_13_x86_64.whl.

File metadata

File hashes

Hashes for potpourri3d-1.3-cp312-cp312-macosx_10_13_x86_64.whl
Algorithm Hash digest
SHA256 eea341833e1cc97c39151df2937693cee407f42450159ae9b8dc0992d0ecb236
MD5 ba6393063af4242f5f26abdafc5e1252
BLAKE2b-256 e862eab2d234e895ea908defbec1e084c470aa4208a5ae77c6c0d2fe7580469a

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-cp312-cp312-macosx_10_13_x86_64.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-cp311-cp311-win_amd64.whl.

File metadata

  • Download URL: potpourri3d-1.3-cp311-cp311-win_amd64.whl
  • Upload date:
  • Size: 6.1 MB
  • Tags: CPython 3.11, Windows x86-64
  • Uploaded using Trusted Publishing? Yes
  • Uploaded via: twine/6.1.0 CPython/3.12.9

File hashes

Hashes for potpourri3d-1.3-cp311-cp311-win_amd64.whl
Algorithm Hash digest
SHA256 b4b400b201d32eed29111782f43fc69e68f4993a6a4f2c1f2c0c40b2f1bfa890
MD5 8dbf107d4a9b81e4d87158a61c2b2d20
BLAKE2b-256 136ba3bc9d506200d87b10e5f642d692b99fa4a15bc84057ffed488fa827ac8a

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-cp311-cp311-win_amd64.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-cp311-cp311-win32.whl.

File metadata

  • Download URL: potpourri3d-1.3-cp311-cp311-win32.whl
  • Upload date:
  • Size: 4.5 MB
  • Tags: CPython 3.11, Windows x86
  • Uploaded using Trusted Publishing? Yes
  • Uploaded via: twine/6.1.0 CPython/3.12.9

File hashes

Hashes for potpourri3d-1.3-cp311-cp311-win32.whl
Algorithm Hash digest
SHA256 6f1cf2e9fdacce5182bc33bee80a09f305bcdd25a9071f4a93f197deb2a9d461
MD5 516c92dbea15d0655784dfa6ceff3655
BLAKE2b-256 c98edd168215a445025e2f24d9903b17a31ddf0ca1f280b4bb6683d7b52974c7

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-cp311-cp311-win32.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-cp311-cp311-musllinux_1_2_x86_64.whl.

File metadata

File hashes

Hashes for potpourri3d-1.3-cp311-cp311-musllinux_1_2_x86_64.whl
Algorithm Hash digest
SHA256 16dc254c25f715c76d2892040a30acbd921dd682180e7a31fb522604c872ca12
MD5 70c944fb360e0305528ec3d300d41a44
BLAKE2b-256 e74323a1705496c9b8b3379f5ec8c3f283562b6621261729672bba2f2c7bdf11

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-cp311-cp311-musllinux_1_2_x86_64.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-cp311-cp311-musllinux_1_2_i686.whl.

File metadata

File hashes

Hashes for potpourri3d-1.3-cp311-cp311-musllinux_1_2_i686.whl
Algorithm Hash digest
SHA256 9750e40ccf6fcfa0767954c3590e2e7c0719c78c7c478ff1e36fc3cfde60cc4e
MD5 89439a6fb66e78778931a70d101b8302
BLAKE2b-256 e5a3b74356b0bcebcb54586c837439ae781e7b1fbf9240bd311bf4cd63a4785b

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-cp311-cp311-musllinux_1_2_i686.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-cp311-cp311-manylinux_2_17_x86_64.manylinux2014_x86_64.whl.

File metadata

File hashes

Hashes for potpourri3d-1.3-cp311-cp311-manylinux_2_17_x86_64.manylinux2014_x86_64.whl
Algorithm Hash digest
SHA256 15ebf8810c5f3414145024f95f866a7cd05a8c01445297b132d56197d8601fec
MD5 f7a474f913323e66337fffd053f1c0b6
BLAKE2b-256 99b6a08932ee718ea71bbecf1c9e89a15c3fad38de6e4eda71a6193c20ac0a89

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-cp311-cp311-manylinux_2_17_x86_64.manylinux2014_x86_64.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-cp311-cp311-manylinux_2_17_i686.manylinux2014_i686.whl.

File metadata

File hashes

Hashes for potpourri3d-1.3-cp311-cp311-manylinux_2_17_i686.manylinux2014_i686.whl
Algorithm Hash digest
SHA256 92ec33543f6672719f6a1b6ba4d6cd76e43a1984ca3e610c0d95898913d57186
MD5 ca5eb27516a6fb491307bd78f23f77a7
BLAKE2b-256 d00e65629a36f100f13ceed9dbdbe31428a359f5293dd0ac5fabf94869025261

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-cp311-cp311-manylinux_2_17_i686.manylinux2014_i686.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-cp311-cp311-macosx_11_0_arm64.whl.

File metadata

File hashes

Hashes for potpourri3d-1.3-cp311-cp311-macosx_11_0_arm64.whl
Algorithm Hash digest
SHA256 12bb631cbb6598bbd2b78e7801f4d87403bd2a24df100fce44e7257674ce3390
MD5 f87e2fd458f79c5c5471331a8a253872
BLAKE2b-256 52df0ddcf6c254d801c197a304ebbfe12a26a820979125bdec40b6f27f85061e

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-cp311-cp311-macosx_11_0_arm64.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-cp311-cp311-macosx_10_9_x86_64.whl.

File metadata

File hashes

Hashes for potpourri3d-1.3-cp311-cp311-macosx_10_9_x86_64.whl
Algorithm Hash digest
SHA256 8299b31501474da8f629423dd1418c67ce93d6ebf9330c1f4749a8be07948f0a
MD5 000a3cd84e199fd9531ff51f41825041
BLAKE2b-256 ba1b4ce8dcab467c41d134740b749bc2054d1377794c708eff9d2268b8b35a28

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-cp311-cp311-macosx_10_9_x86_64.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-cp310-cp310-win_amd64.whl.

File metadata

  • Download URL: potpourri3d-1.3-cp310-cp310-win_amd64.whl
  • Upload date:
  • Size: 6.1 MB
  • Tags: CPython 3.10, Windows x86-64
  • Uploaded using Trusted Publishing? Yes
  • Uploaded via: twine/6.1.0 CPython/3.12.9

File hashes

Hashes for potpourri3d-1.3-cp310-cp310-win_amd64.whl
Algorithm Hash digest
SHA256 f27d7f7c217092df712a4c285b908fff23beb396790102674172611ec0dacc6c
MD5 7c4acbde3a2c352b1d9316a5bf0313b5
BLAKE2b-256 e4f33d306abc0c52d62ce84f11398eb004a209041d720757706d3eae75279e70

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-cp310-cp310-win_amd64.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-cp310-cp310-win32.whl.

File metadata

  • Download URL: potpourri3d-1.3-cp310-cp310-win32.whl
  • Upload date:
  • Size: 4.5 MB
  • Tags: CPython 3.10, Windows x86
  • Uploaded using Trusted Publishing? Yes
  • Uploaded via: twine/6.1.0 CPython/3.12.9

File hashes

Hashes for potpourri3d-1.3-cp310-cp310-win32.whl
Algorithm Hash digest
SHA256 60cd89f7a96578ebbbbcf3dc815352fa4c1ca56832a8e1436eead0c109468da6
MD5 65c446e25c71f73e5437b6e2623275a7
BLAKE2b-256 96851ca2bdb9ccb39d659c5bf62529d01cef3e3d5ad4c5042035d9389110f7d8

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-cp310-cp310-win32.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-cp310-cp310-musllinux_1_2_x86_64.whl.

File metadata

File hashes

Hashes for potpourri3d-1.3-cp310-cp310-musllinux_1_2_x86_64.whl
Algorithm Hash digest
SHA256 dc7dcc2967cc85c6606bb5c1d50fe328c24abe40506b9d443f0405b2e54de70f
MD5 7467356a2e3c98f537091df8127bd5cb
BLAKE2b-256 918b78d976959de91a13532aa18ea812fa8648bf230a87dfc18f2769cfc8622a

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-cp310-cp310-musllinux_1_2_x86_64.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-cp310-cp310-musllinux_1_2_i686.whl.

File metadata

File hashes

Hashes for potpourri3d-1.3-cp310-cp310-musllinux_1_2_i686.whl
Algorithm Hash digest
SHA256 a48805cfcdc93acaaf5d296dfffe53f218def866c795b365578553b8702c9cb8
MD5 95468e88b31c86b15de79492c9ce6df3
BLAKE2b-256 ce0e62490fbcd1beaeb849bb79b0619752056012a2abba2b00008dd815ae1ec4

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-cp310-cp310-musllinux_1_2_i686.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-cp310-cp310-manylinux_2_17_x86_64.manylinux2014_x86_64.whl.

File metadata

File hashes

Hashes for potpourri3d-1.3-cp310-cp310-manylinux_2_17_x86_64.manylinux2014_x86_64.whl
Algorithm Hash digest
SHA256 ca0274a6f8db5a1dbb8d04531519dae6815de3e9f25f8bd206386d0e0b0a7b50
MD5 06e3ad13c77e6a0e6346c4cccd78da0f
BLAKE2b-256 6277a9fd86ebf08b3bca78b62b751fc291cad8e585d0282bba140dfebcbf63e2

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-cp310-cp310-manylinux_2_17_x86_64.manylinux2014_x86_64.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-cp310-cp310-manylinux_2_17_i686.manylinux2014_i686.whl.

File metadata

File hashes

Hashes for potpourri3d-1.3-cp310-cp310-manylinux_2_17_i686.manylinux2014_i686.whl
Algorithm Hash digest
SHA256 e8816230192de55643765c0a063cdfe75ce50e2697c6bf33d6a2fc6db8a785a8
MD5 b6389985c106aefc45002dacebeb3607
BLAKE2b-256 44a7be967b851036e6f019f390539875c90e124cca8523e026c817100b88f8df

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-cp310-cp310-manylinux_2_17_i686.manylinux2014_i686.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-cp310-cp310-macosx_11_0_arm64.whl.

File metadata

File hashes

Hashes for potpourri3d-1.3-cp310-cp310-macosx_11_0_arm64.whl
Algorithm Hash digest
SHA256 c04e5ea8803477525d54d50bfc8fb10894db8cca47549ceaf93893b8d62be6e8
MD5 6a48b732f53fd9c74df8421d97150783
BLAKE2b-256 0ab197e97770096217c793cb1c20fa9388363fa7a81350353db90c30022ec585

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-cp310-cp310-macosx_11_0_arm64.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-cp310-cp310-macosx_10_9_x86_64.whl.

File metadata

File hashes

Hashes for potpourri3d-1.3-cp310-cp310-macosx_10_9_x86_64.whl
Algorithm Hash digest
SHA256 cdbc05081febb341ec90469e7280cc77cfafbd9a210ede3cd3985d732ec71ad0
MD5 0533969b709d08613be865ad4f85636b
BLAKE2b-256 beaf3c9844aa8c93066d54f4d9fdebf3e9f0e4ba0588627a1446bda1ce6e68c5

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-cp310-cp310-macosx_10_9_x86_64.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-cp39-cp39-win_amd64.whl.

File metadata

  • Download URL: potpourri3d-1.3-cp39-cp39-win_amd64.whl
  • Upload date:
  • Size: 6.1 MB
  • Tags: CPython 3.9, Windows x86-64
  • Uploaded using Trusted Publishing? Yes
  • Uploaded via: twine/6.1.0 CPython/3.12.9

File hashes

Hashes for potpourri3d-1.3-cp39-cp39-win_amd64.whl
Algorithm Hash digest
SHA256 d733b737c922a0f50194de0f6a18b7f300ce2752233a425fcdecaf7719717556
MD5 e1d124acd86233a011fe332c528cd421
BLAKE2b-256 fefd27fea12adaadf42dcfaaa9c411f73ba67feb1b934b9861d7c131e0a6119e

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-cp39-cp39-win_amd64.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-cp39-cp39-win32.whl.

File metadata

  • Download URL: potpourri3d-1.3-cp39-cp39-win32.whl
  • Upload date:
  • Size: 4.5 MB
  • Tags: CPython 3.9, Windows x86
  • Uploaded using Trusted Publishing? Yes
  • Uploaded via: twine/6.1.0 CPython/3.12.9

File hashes

Hashes for potpourri3d-1.3-cp39-cp39-win32.whl
Algorithm Hash digest
SHA256 e2fe7fe0181db5977abcd6d41aff562b900ba7fa77ef24550f2b22122436ec4d
MD5 5474d2704c571154a526151231ac329d
BLAKE2b-256 b578f72f3560d2e9c19927a41cb0ca468060e84fe0e8c4f73562a3ad4619640f

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-cp39-cp39-win32.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-cp39-cp39-musllinux_1_2_x86_64.whl.

File metadata

File hashes

Hashes for potpourri3d-1.3-cp39-cp39-musllinux_1_2_x86_64.whl
Algorithm Hash digest
SHA256 28716ff16e39e0ad6abb78773bcaf2fe5f6627cf7a3d11aed5f9f5ac392e5b36
MD5 9019121a8b40c113724650edbf77b9cc
BLAKE2b-256 2b8b4e3143c383acf8035b7a55909141dccd44f07d115964ccb9424c75b1cb09

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-cp39-cp39-musllinux_1_2_x86_64.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-cp39-cp39-musllinux_1_2_i686.whl.

File metadata

File hashes

Hashes for potpourri3d-1.3-cp39-cp39-musllinux_1_2_i686.whl
Algorithm Hash digest
SHA256 04930f7e922c41ca13b22f2604639b8e056a8727eaef4509e581eb2eff6a38fa
MD5 1cd2232aac9e48ccb725d659400ce3a2
BLAKE2b-256 14415c91d324aaf870301c04ed6067b12bd3cb7c2af4dbc100c4ce44b224ab95

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-cp39-cp39-musllinux_1_2_i686.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-cp39-cp39-manylinux_2_17_x86_64.manylinux2014_x86_64.whl.

File metadata

File hashes

Hashes for potpourri3d-1.3-cp39-cp39-manylinux_2_17_x86_64.manylinux2014_x86_64.whl
Algorithm Hash digest
SHA256 9ed849aed00413ee943f030a82d1060b2e6475245ee6adb147c23c31566952ae
MD5 e6247a5862ec571cfc5bbeac09f4be7c
BLAKE2b-256 c23d5146c80c7123a769d7be24a5c3075cd03bd8c8f184dac25646fbedb004f6

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-cp39-cp39-manylinux_2_17_x86_64.manylinux2014_x86_64.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-cp39-cp39-manylinux_2_17_i686.manylinux2014_i686.whl.

File metadata

File hashes

Hashes for potpourri3d-1.3-cp39-cp39-manylinux_2_17_i686.manylinux2014_i686.whl
Algorithm Hash digest
SHA256 f7208c36a2c37698998d38cb7c1e37d7924b2b1f317a02b09c63a94aeb7647e0
MD5 d514cbffad56906b3490e30da1072514
BLAKE2b-256 f29b6e5b9b13b6eaf4baeab184bfeb3d43d5e464595e11dec0c8018973c44fa9

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-cp39-cp39-manylinux_2_17_i686.manylinux2014_i686.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-cp39-cp39-macosx_11_0_arm64.whl.

File metadata

File hashes

Hashes for potpourri3d-1.3-cp39-cp39-macosx_11_0_arm64.whl
Algorithm Hash digest
SHA256 074822d99a026abdf8c4b7e0c85528bd2aa8b3bc8f1ca781a1aeb2cae08893ba
MD5 bc01da96d3f34eea5361943b2bdfe896
BLAKE2b-256 dc1650320c28bcb1a156c50e125479e1f8e3a18464367838deacc8fa34e71293

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-cp39-cp39-macosx_11_0_arm64.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-cp39-cp39-macosx_10_9_x86_64.whl.

File metadata

File hashes

Hashes for potpourri3d-1.3-cp39-cp39-macosx_10_9_x86_64.whl
Algorithm Hash digest
SHA256 4232e9e9e8284269cea5fd8062f9c1ef67fad4f782b72412ada2251834efa200
MD5 7401dcd9c234920fc341d7fa7bf0ae42
BLAKE2b-256 b23a3ec00b9f5fa3293fe961911cc1de207c5d73be9739745639164b23dd52fa

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-cp39-cp39-macosx_10_9_x86_64.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-cp38-cp38-win_amd64.whl.

File metadata

  • Download URL: potpourri3d-1.3-cp38-cp38-win_amd64.whl
  • Upload date:
  • Size: 6.1 MB
  • Tags: CPython 3.8, Windows x86-64
  • Uploaded using Trusted Publishing? Yes
  • Uploaded via: twine/6.1.0 CPython/3.12.9

File hashes

Hashes for potpourri3d-1.3-cp38-cp38-win_amd64.whl
Algorithm Hash digest
SHA256 672b13ccb067c7c4caf4171819e5c04c532fa966a13a929e52629d47837f4ee7
MD5 26e85f4b6b6cc196e574895359fca9da
BLAKE2b-256 c80257cdb304ff280b9ea174e7c631c264be5cf2c1dfeec1876bdec640e0e128

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-cp38-cp38-win_amd64.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-cp38-cp38-win32.whl.

File metadata

  • Download URL: potpourri3d-1.3-cp38-cp38-win32.whl
  • Upload date:
  • Size: 4.4 MB
  • Tags: CPython 3.8, Windows x86
  • Uploaded using Trusted Publishing? Yes
  • Uploaded via: twine/6.1.0 CPython/3.12.9

File hashes

Hashes for potpourri3d-1.3-cp38-cp38-win32.whl
Algorithm Hash digest
SHA256 713ef1e238048a5245f9d16bd82798a8806138525b2a36afc6384a128af46b61
MD5 f39cb973cc27abbf5bc51fc6be12cdff
BLAKE2b-256 6cfbf52a614b22c6bdbb9ed341fca33a6d13de2415691247417a3d5429b02b2a

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-cp38-cp38-win32.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-cp38-cp38-musllinux_1_2_x86_64.whl.

File metadata

File hashes

Hashes for potpourri3d-1.3-cp38-cp38-musllinux_1_2_x86_64.whl
Algorithm Hash digest
SHA256 f0651092710a7f8a9bafd8d7f2360c8a0a8dd4c8e89e6887617738f598d47a76
MD5 0ecafee81d52710f530ccd04a5418e00
BLAKE2b-256 686b6f9e61cfc6fefb0244b34f8f496564cf6d75496dab014b9ac1a7cafedc5a

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-cp38-cp38-musllinux_1_2_x86_64.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-cp38-cp38-musllinux_1_2_i686.whl.

File metadata

File hashes

Hashes for potpourri3d-1.3-cp38-cp38-musllinux_1_2_i686.whl
Algorithm Hash digest
SHA256 67114a3b27a6f707839c673e47bd07baf27150789fda5ed9ab7345b029e3e04a
MD5 24c90a5bcd812baa221febbe473c3bab
BLAKE2b-256 fdb5119cbd17b52dd454610c67fb03c44fb1489d40a80825639823409eb185ba

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-cp38-cp38-musllinux_1_2_i686.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-cp38-cp38-manylinux_2_17_x86_64.manylinux2014_x86_64.whl.

File metadata

File hashes

Hashes for potpourri3d-1.3-cp38-cp38-manylinux_2_17_x86_64.manylinux2014_x86_64.whl
Algorithm Hash digest
SHA256 b853f4a0231da9936385dcca9c9dfe4bcee051f073775732d745e9fdfe044e5c
MD5 6f410c4056e796c9bfde3ca4f5e0eaa1
BLAKE2b-256 40b46a3269569f49a295dd137e956bd661082fbe515f3c59897b2cb53b1ee635

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-cp38-cp38-manylinux_2_17_x86_64.manylinux2014_x86_64.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-cp38-cp38-manylinux_2_17_i686.manylinux2014_i686.whl.

File metadata

File hashes

Hashes for potpourri3d-1.3-cp38-cp38-manylinux_2_17_i686.manylinux2014_i686.whl
Algorithm Hash digest
SHA256 6c1dc66296860e5900c188def06c0ccb7daea9fc93d0ff7cd8cb08a8b4f54735
MD5 f27709e16e6fcb20735599dbc4c05bdb
BLAKE2b-256 e2be5c39188cf2edd18f8d54749ccc4aecdaee3b06e98577c48bcd6017fc2733

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-cp38-cp38-manylinux_2_17_i686.manylinux2014_i686.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-cp38-cp38-macosx_11_0_arm64.whl.

File metadata

File hashes

Hashes for potpourri3d-1.3-cp38-cp38-macosx_11_0_arm64.whl
Algorithm Hash digest
SHA256 a6ccd8c73c4c92d67d24cd1d03e0816c241944799c8a0422af84d7ed82dc3b98
MD5 58917369dd68c9ba16a3bc3c5e6c3d63
BLAKE2b-256 eb87e8e0411b50182fdb22750a2713e34c39ffe6b615e00880b4dbd583551aff

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-cp38-cp38-macosx_11_0_arm64.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-cp38-cp38-macosx_10_9_x86_64.whl.

File metadata

File hashes

Hashes for potpourri3d-1.3-cp38-cp38-macosx_10_9_x86_64.whl
Algorithm Hash digest
SHA256 7c320171363fb37a86f52eb0bbbecb8a0285dbf567a805841f279f99efe2952b
MD5 b93a07b3628627438eeace9d02cb7dd0
BLAKE2b-256 88ccaceeed0a08222a1dc5239b037ca11087e951995e84be7f59bc2570f76465

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-cp38-cp38-macosx_10_9_x86_64.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-cp37-cp37m-win_amd64.whl.

File metadata

  • Download URL: potpourri3d-1.3-cp37-cp37m-win_amd64.whl
  • Upload date:
  • Size: 6.1 MB
  • Tags: CPython 3.7m, Windows x86-64
  • Uploaded using Trusted Publishing? Yes
  • Uploaded via: twine/6.1.0 CPython/3.12.9

File hashes

Hashes for potpourri3d-1.3-cp37-cp37m-win_amd64.whl
Algorithm Hash digest
SHA256 3df27dfaf76ca4f3b86bee7da95591cc0066fabbc1cb610a96701d8d6317acad
MD5 ef8ead8590ae36f10b15e4070b60e74f
BLAKE2b-256 481143ee38610aeec4fc0633f871ef672c8a5b9540f4ebf8506240ef2de8dd6b

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-cp37-cp37m-win_amd64.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-cp37-cp37m-win32.whl.

File metadata

  • Download URL: potpourri3d-1.3-cp37-cp37m-win32.whl
  • Upload date:
  • Size: 4.5 MB
  • Tags: CPython 3.7m, Windows x86
  • Uploaded using Trusted Publishing? Yes
  • Uploaded via: twine/6.1.0 CPython/3.12.9

File hashes

Hashes for potpourri3d-1.3-cp37-cp37m-win32.whl
Algorithm Hash digest
SHA256 f3cd4d7e58ebea7ec06a6b49520f74f2e82f72b97e5eb2240a22628e811f7993
MD5 470f3c5b26e93ccd7d3d91823d989eea
BLAKE2b-256 4b173c166b223a75e3a64ab3d0f351e1957c5799cf4fb2c6b2e3d8c61d44fc6d

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-cp37-cp37m-win32.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-cp37-cp37m-musllinux_1_2_x86_64.whl.

File metadata

File hashes

Hashes for potpourri3d-1.3-cp37-cp37m-musllinux_1_2_x86_64.whl
Algorithm Hash digest
SHA256 9a5316ab6760be969b286f32f7b85e7ff46884cbbc6d0a8ca044b44a3c845c18
MD5 65a8bb7ea66155bf2df57d4b465a2b12
BLAKE2b-256 ca0ee1fd92f13a1551a4e5cd8ff2a15c903c45963c4978bad24c915af5405fa7

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-cp37-cp37m-musllinux_1_2_x86_64.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-cp37-cp37m-musllinux_1_2_i686.whl.

File metadata

File hashes

Hashes for potpourri3d-1.3-cp37-cp37m-musllinux_1_2_i686.whl
Algorithm Hash digest
SHA256 37c9a1a627fe127380d6f4349b4ad477011f69783e753fb3a318f89246d3f31a
MD5 8c61be0f111f4c14ff493b3da70fb876
BLAKE2b-256 22439d1c21255f89ef113132bba6979bb91ea112deb6792f43aa90b13a572907

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-cp37-cp37m-musllinux_1_2_i686.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-cp37-cp37m-manylinux_2_17_x86_64.manylinux2014_x86_64.whl.

File metadata

File hashes

Hashes for potpourri3d-1.3-cp37-cp37m-manylinux_2_17_x86_64.manylinux2014_x86_64.whl
Algorithm Hash digest
SHA256 c1dfb9737daa289fc16b14de2e38c06b5fb9fb8006c2f8018df84b76e2e6232d
MD5 1ffd6a7d78d6cfb7a32100559be229a4
BLAKE2b-256 cb4562e5c272ea5a2edf246e86b440f14b6d72bebe125e6fc338febd8da13f59

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-cp37-cp37m-manylinux_2_17_x86_64.manylinux2014_x86_64.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-cp37-cp37m-manylinux_2_17_i686.manylinux2014_i686.whl.

File metadata

File hashes

Hashes for potpourri3d-1.3-cp37-cp37m-manylinux_2_17_i686.manylinux2014_i686.whl
Algorithm Hash digest
SHA256 4c22fee6c778d8582a095e1eccbeca84d459d34cdaf3c363a0a1acbfd508548d
MD5 0b59b53c97d521919b8adbe25280e4d9
BLAKE2b-256 cf2845c0a1b663a651a2d01e37da961c947662e877695b6cc508b1e343ed4f27

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-cp37-cp37m-manylinux_2_17_i686.manylinux2014_i686.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

File details

Details for the file potpourri3d-1.3-cp37-cp37m-macosx_10_9_x86_64.whl.

File metadata

File hashes

Hashes for potpourri3d-1.3-cp37-cp37m-macosx_10_9_x86_64.whl
Algorithm Hash digest
SHA256 84a094ade5622eb23b6300167d82a986b768a403a13f4a1472d595f8fb2ce34c
MD5 9f9decd1645060b131082b3d8eea4558
BLAKE2b-256 af07c6f7b36ad84474e5e433920f158c56302cc34793d8b5abe45d1d1282c04d

See more details on using hashes here.

Provenance

The following attestation bundles were made for potpourri3d-1.3-cp37-cp37m-macosx_10_9_x86_64.whl:

Publisher: publish.yml on nmwsharp/potpourri3d

Attestations: Values shown here reflect the state when the release was signed and may no longer be current.

Supported by

AWS Cloud computing and Security Sponsor Datadog Monitoring Fastly CDN Google Download Analytics Pingdom Monitoring Sentry Error logging StatusPage Status page