This is the historically first application, and the largest one.
It deals with convex pointed polyhedra. It allows to define a polyhedron either as a convex hull of a point set, an intersection of halfspaces, or as an incidence matrix without any embedding. Then you can ask for a plenty of its (especially combinatorial) properties, construct new polyhedra by modifying it, or study the behavior of the objective functions.
There is a wide range of visualization methods for polyhedra, even for dimensions > 4 and purely combinatorial descriptions, including interfaces to interactive geometry viewers (such as JavaView or geomview), generating PostScript drawings and povray scene files.
An undirected graph with given node coordinates and a bounding box
Since a Voronoi polyhedron is unbounded it must be artificially bounded for visualization purposes. Allowed is any set of hyperplanes which makes the projection onto the last d-1 coordinates bounded. By default, these are the vertical facets of a suitably scaled cube.
The coordinates of the nodes of the graph.
The Groebner basis of the homogeneous toric ideal associated to the polytope, the term order is given in matrix form.
The term order in matrix form; if not square, then a tie breaker is used.
A term order by name;
allowed acronyms are lex
, deglex
and degrevlex
.
Polytope all of whose vertex coordinates are integral
The coefficients of the Ehrhart polynomial starting at the constant coefficient.
The entry (i,j) equals the lattice distance of vertex j from facet i.
The maximal integral width of the polytope with respect to the facet normals.
The integral width of the polytope with respect to each facet normal.
The polytope is Gorenstein if a dilation of the polytope is reflexive up to translation.
If the polytope is Gorenstein then this is the multiple such that the polytope is reflexive.
If the polytope is Gorenstein, then this is the unique interior lattice point in the multiple of the polytope that is reflexive.
The Groebner basis for the toric ideal associated to the lattice points in the polytope using any term order.
The coefficients of the h^*-polynomial starting at the constant coefficient
DIM+1-LATTICE_DEGREE or the smallest integer k such that k*P has an interior lattice point.
True if the polytope contains no lattice points other than the vertices.
The polytope is normal if the cone spanned by P x {1} is generated in height 1.
The polytope is smooth if the associated projective variety is smooth; the determinant of the edge directions is +/-1 at every vertex.
The polytope is terminal if there is exactly one interior lattice point and all other lattice points are vertices.
The polytope is very ample if the Hilbert Basis of the cone spanned by the edge-directions of any vertex lies inside the polytope.
Vector containing the distances of a given point v from all facets
The number of LATTICE_POINTS in the n-th dilation of the polytope
Int | n | dilation factor |
A linear program specified by a linear or abstract objective function
Abstract objective function. Defines a direction for each edge such that each non-empty face has a unique source and a unique sink. The i-th element is the value of the objective function at vertex number i. Only defined for bounded polytopes.
Subgraph of Polytope::GRAPH. Consists only of directed arcs along which the value of the objective function increases.
Linear objective function. In d-space a linear objective function is given by a (d+1)-vector. The first coordinate specifies a constant that is added to the resulting value.
Indices of vertices at which the maximum of the objective function is attained.
Maximum value of the objective function. Negated if linear problem is unbounded.
Coordinates of a (possibly not unique) affine vertex at which the maximum of the objective function is attained.
Expected average path length for a simplex algorithm employing "random edge" pivoting strategy.
Subgraph of BOUNDED_GRAPH. Consists only of directed arcs along which the value of the objective function increases.
Array of in-degrees for all nodes of DIRECTED_GRAPH or numbers of objective decreasing edges at each vertex
Array of out-degrees for all nodes of DIRECTED_GRAPH or numbers of objective increasing edges at each vertex
The object point configuration also deals with non-convex finite point sets.
The splits of the point configuration, i.e., hyperplanes cutting the configuration in two parts such that we have a regular subdivision.
The splits that are coarsenings of the current POLYTOPAL_SUBDIVISION. If the subdivision is regular these form the unique split decomposition of the corresponding weight function.
Two SPLITS are compatible if the defining hyperplanes do not intersect in the interior of the point configuration. This defines a graph.
The polytope being the convex hull of the point configuration.
Unique names assigned to the POINTS. If specified, they are shown by visualization tools instead of point indices.
Graph of the point configuration. Two points are adjacent if they lie in a common edge of the CONVEX_HULL.
Polytopal Subdivision of the point configuration. Each line contains indices from POINTS comprising a facet of the subdivision.
Some triangulation of the point configuration.
DOC_FIXME: Incomprehensible description! For each facet the set of simplex indices of BOUNDARY that triangulate it.
GKZ-vector
See Chapter 7 in Gelfand, Kapranov, and Zelevinsky:Discriminants, Resultants and Multidimensional Determinants, Birkhäuser 1994
The splits that are coarsenings of the current TRIANGULATION. If the triangulation is regular these form the unique split decomposition of the corresponding weight function.
Polytope::VIF_CYCLIC_NORMAL of the CONVEX_HULL, but with the indices form POINTS instead of Polytope::VERTICES
UNDOCUMENTED
option list: | Visual::Polygons::decorations |
For each simplex in the TRIANGULATION, this contains the sign of the determinant of its coordinate matrix, which is the orientation of the simplex.
Array<int> |
Visualize a point configuration.
Visualize the POINTS of a point configuration.
A bounded or unbounded pointed polyhedron. Note that a pointed polyhedron is projectively equivalent to a polytope. Scalar is the numeric data type used for the coordinates.
The splits of the polytope, i.e., hyperplanes cutting the polytope in two parts such that we have a regular subdivision.
The splits that are coarsenings of the current POLYTOPAL_SUBDIVISION. If the subdivision is regular these form the unique split decomposition of the corresponding weight function.
Two SPLITS are compatible if the defining hyperplanes do not intersect in the interior of the polytope. This defines a graph.
Dimension of the affine hull of the polyhedron = dimension of the polyhedron. If the polytope is given purely combinatorially, this is the dimension of a minimal embedding space deduced from the combinatorial structure.
Equations that hold for all points of the polyhedron.
A vector (A0, A1, ..., Ad) describes the hyperplane of all points (1, x1, ..., xd) such that A0 + A1 x1 + ... + Ad xd = 0.
Input section only. Ask for AFFINE_HULL if you want to see an irredundant description of the affine span.
Unique names assigned to the FACETS, analogous to VERTEX_LABELS.
Inequalities that describe half-spaces such that the polyhedron is their intersection. Redundancies are allowed. Dual to POINTS.
A vector (A0, A1, ..., Ad) defines the (closed affine) half-space of points (1, x1, ..., xd) such that A0 + A1 x1 + ... + Ad xd >= 0.
Input section only. Ask for FACETS and AFFINE_HULL if you want to compute an H-representation from a V-representation.
Basis of the linear subspace orthogonal to all INEQUALITIES and EQUATIONS
The minimal angle between any two vertices (seen from the VERTEX_BARYCENTER).
Points such that the polyhedron is their convex hull. Redundancies are allowed. The vector (x0, x1, ... xd) represents a point in d-space given in homogeneous coordinates. Affine points are identified by x0 > 0. Points with x0 = 0 can be interpreted as rays.
polymake automatically normalizes each coordinate vector, dividing them by the first non-zero element. The clients and rule subroutines can always assume that x0 is either 0 or 1. Dual to INEQUALITIES.
Input section only. Ask for VERTICES if you want to compute a V-representation from an H-representation.
True if all vertices of the polyhedron have non-negative coordinates, that is, it lies entirely in the positive orthant.
A weighted inner point depending on the outer angle called Steiner point for all faces of dimensions 2 to d.
The center of gravity of the vertices of a bounded polytope.
Unique names assigned to the VERTICES. If specified, they are shown by visualization tools instead of vertex indices.
For a polytope build from scratch, you should create this property by yourself, either manually in a text editor, or with a client program.
If you build a polytope with a construction function taking some other input polytope(s), you can create the labels automatically if you call the function with a relabel option. The exact format of the labels is dependent on the construction, and is described in the corresponding help topic.
The i-th row is the normal vector of a hyperplane separating the i-th vertex from the others. This property is a by-product of redundant point elimination algorithm.
DOC_FIXME: Incomprehensible! Contains the vector configuration for which a zonotope can be built.
Let M be the vertex-facet incidence matrix, then the Altshulter determinant is defined as max{det(M ∗ M^T), det(M^T &lowast M)}.
h-vector of the bounded subcomplex, defined for not necessarily bounded polyhedra which are simple (as polyhedra, i.e., VERTEX_DEGREES on the FAR_FACE do not matter). Coincides with the reverse h-vector of the dual simplicial ball. Note that this vector will usually start with a number of zero entries.
h-vector, defined via recursion on the face lattice of a polytope. Coincides for simple polytopes with the combinatorial definition of the h-vector via abstract objective functions.
All intermediate polytopes (with respect to the given insertion order) in the beneath-and-beyond algorithm are simplicial. We have the implications: VERTICES in general position => ESSENTIALLY_GENERIC => SIMPLICIAL
fik is the number of incident pairs of i-faces and k-faces; the main diagonal contains the F_VECTOR.
transposed VERTICES_IN_FACETS Notice that this is a temporary property; it will not be stored in any file.
Vertex-edge graph.
Difference of the vertices for each edge (only defined up to signs).
(Toric) g-vector, defined via the (generalized) h-vector as gi = hi - hi-1.
The face lattice of the polytope organized as a directed graph. Each node corresponds to some proper face of the polytope. The nodes corresponding to the vertices and facets appear in the same order as the elements of VERTICES and FACETS properties.
Two special nodes represent the whole polytope and the empty face.
h-vector, defined via recursion on the face lattice of a polytope. Coincides for simplicial polytopes with the combinatorial definition of the h-vector via shellings
Lists for each occurring size (= number of incident facets or ridges) of a subridge how many there are.
Lists for each occurring size (= number of incident vertices or edges) of a 2-face how many there are.
Vertex-facet incidence matrix, with rows corresponding to facets and columns to vertices. Vertices and facets are numbered from 0 to N_VERTICES-1 rsp. N_FACETS-1, according to their order in VERTICES rsp. FACETS.
Similar to VERTICES_IN_FACETS, but with columns corresponding to POINTS instead of VERTICES. This property is a byproduct of convex hull computation algorithms. It is discarded as soon as VERTICES_IN_FACETS is computed.
Similar to VERTICES_IN_FACETS, but with rows corresponding to INEQUALITIES instead of FACETS. This property is a byproduct of convex hull computation algorithms. It is discarded as soon as VERTICES_IN_FACETS is computed.
Valid strict inequality for all affine points of the polyhedron.
Polytopal Subdivision of the polytope using only its vertices. Each line contains indices from VERTICES comprising a facet of the subdivision.
Some triangulation of the polytope using only its vertices. Each line contains indices from VERTICES comprising a simplex.
For each facet the set of simplex indices of BOUNDARY that triangulate it.
GKZ-vector
See Chapter 7 in Gelfand, Kapranov, and Zelevinsky:Discriminants, Resultants and Multidimensional Determinants, Birkhäuser 1994
The splits that are coarsenings of the current TRIANGULATION. If the triangulation is regular these form the unique split decomposition of the corresponding weight function.
Bounded subcomplex. FIXME: type should be a newly defined "PolyhedralComplex"
Graph of the bounded subcomplex.
Each edge indicates the maximal dimension of a bounded face containing it. Mainly used for visualization purposes.
Difference of the vertices for each edge (only defined up to signs).
HASSE_DIAGRAM constrained to affine vertices Nodes representing the maximal inclusion-independent faces are connected to the top-node regardless of their dimension
A linear objective function for which each unbounded edge is increasing; only defined for unbounded polyhedra.
Reordered transposed VERTICES_IN_FACETS. Dual to VIF_CYCLIC_NORMAL.
Reordered DUAL_GRAPH for 3d-polytopes. The neighbor facets are listed in the order corresponding to VIF_CYCLIC_NORMAL, so that the first two vertices in VIF_CYCLIC_NORMAL make up the ridge to the first neighbor facet and so on.
Reordered GRAPH. Dual to NEIGHBOR_FACETS_CYCLIC_NORMAL.
Holds one special projection (the Schlegel diagram) of the polytope.
Reordered VERTICES_IN_FACETS for 2d and 3d-polytopes. Vertices are listed in the order of their appearance when traversing the facet border counterclockwise seen from outside of the polytope.
For a 2d-polytope (which is a closed polygon), lists all vertices in the border traversing order.
Find the vertices by given labels.
The diameter of the DUAL_GRAPH
True if the DUAL_GRAPH contains no triangle
True if the GRAPH contains no triangle
Connectivity of the DUAL_GRAPH this is the minimum number of nodes that have to be removed from the DUAL_GRAPH to make it disconnected
True if the DUAL_GRAPH is bipartite
Facet degrees of the polytope. The degree of a facet is the number of adjacent facets.
Vector<Int> | - in the same order as FACETS
|
The number of ridges (faces of codimension 2) of the polytope equals the number of edges of the DUAL_GRAPH
Vertex degrees of the polytope
Vector<Int> | - in the same order as VERTICES
|
Prettily print the cd-index given in CD_INDEX_COEFFICIENTS
Difference of the black and white nodes if the DUAL_GRAPH is BIPARTITE. Otherwise -1.
the orientation of the simplices of TRIANGULATION_INT in the given order of the POINTS
Array<Int> | - +1/-1 array specifying the sign of the determinant of each simplex |
For each simplex in the TRIANGULATION, contains the sign of the determinant of its coordinate matrix, telling about its orientation.
Array<Int> |
Indices of FACETS that are bounded.
Set<Int> |
Indices of VERTICES that are no rays.
Set<Int> |
Generate the Gale diagram of a d-polyhedron with at most d+4 vertices.
Visual::Gale |
Create a Schlegel diagram and draw it.
FIXME | proj_facet | decorations for the Edges of the projection face |
option list: | schlegel_init | |
option list: | Visual::Wire::decorations |
Visual::SchlegelDiagram |
Visualize a polytope as a graph (if 1d), or as a solid object (if 2d or 3d), or as a Schlegel diagram (4d).
Visualize the BOUNDED_GRAPH of a polyhedron.
Int | seed | random seed value for the string embedder |
option list: | Visual::Graph::decorations |
Visual::PolytopeGraph |
Visualize the dual face lattice of a polyhedron as a multi-layer graph.
Int | seed | random seed value for the node placement |
option list: | Visual::Lattice::decorations |
Visual::PolytopeLattice |
Visualize the DUAL_GRAPH of a polyhedron.
Int | seed | random seed value for the string embedder |
option list: | Visual::Graph::decorations |
Visual::Graph |
Visualize the HASSE_DIAGRAM of a polyhedron as a multi-layer graph.
Int | seed | random seed value for the node placement |
option list: | Visual::Lattice::decorations |
Visual::PolytopeLattice |
Visualize the GRAPH of a polyhedron.
Int | seed | random seed value for the string embedder |
option list: | Visual::Graph::decorations |
Visual::PolytopeGraph |
Visualize the TRIANGULATION_BOUNDARY of the polytope. Obsolete: the preferred procedure is to create a SimplicialComplex using the boundary_complex client of the application <a target="_top" href="../../topaz/model.html">topaz</a> and call its VISUAL method.
A pointed polyhedron realized in Rd.
Convex hull and related algorithms use floating-point arithmetics. Due to numerical errors inherent to this kind of computations, the resulting combinatorial description can be arbitrarily far away from the truth, or even not correspond to any valid polytope. You have been warned.
None of the standard construction clients produces objects of this type. If you want to get one, create it with the explicit constructor or convert_to.
The lattice points on the boundary of the polytope, including the vertices
The lattice points strictly in the interior of the polytope
This is the defining property: A polytope is lattice if each vertex has integer coordinates.
Polytope propagation means to define a polytope inductively by assigning vectors to arcs of a directed graph. At each node of such a graph a polytope arises as the joint convex hull of the polytopes at the translated sources of the inward pointing arcs.
For details see
Joswig: Polytope Propagation on Graphs.Chapter 6 inPachter/Sturmfels: Algebraic Statistics for Computational Biology, Cambridge 2005.
Directed graph to define the propagated polytope. There is a (translation) vector assigned to each arc. We assume that this graph is acyclic with a unique sink.
A Schlegel diagram of a polytope
The intersection point of the projection facet and the view ray.
Rotation matrix making the projection facet coinciding with (0 0 0 -1) We want a negatively oriented coordinate system since the view point lies on the negative side of the facet.
Matrix of a projective transformation mapping the whole polytope into the FACET The points belonging to this facet stay fixed.
Coordinates in affine 3-space of the vertices which correspond to a 3-dimensional (Schlegel-) projection of a 4-polytope.
Draw the Schlegel diagram
pm::perl::Hash | proj_facet | decoration for the edges of the projection face |
option list: | Visual::Graph::decorations |
Visual::SchlegelDiagram |
Bounded subcomplex of an unbounded polyhedron, which is associated with a finite metric space. The tight span is 1-dimensional if and only if the metric is tree-like. In this sense, the tight span captures the deviation of the metric from a tree-like one.
Labels for the rows and columns of the METRIC space. Default TAXA are just consecutive numbers.
Visualize the BOUNDED_GRAPH of a tight span.
Int | seed | random seed value for the string embedder |
option list: | Visual::Graph::decorations |
Visual::PolytopeGraph |
Visualize the splits of a finite metric space (that is, a planar image of a tight span). Calls SplitsTree.
Visual::FiniteMetricSpace |
This is a variation of Polytope::VISUAL_BOUNDED_GRAPH for the special case of a tight span. The tropical vertices are embedded according to the METRIC, the others are hanged in between.
Int | seed | random seed value for the string embedder |
String | norm | which norm to use when calculating the distances between metric vectors ("max" or "square") |
option list: | Visual::Graph::decorations |
Visual::Graph |
Visualization of the point configuration.
Visualize the POLYTOPAL_SUBDIVISION of a point configuration
Visualize the TRIANGULATION of a point configuration
Draw the edges of the TRIANGULATION_BOUNDARY. The facets are made transparent.
Visualization of a polytope as a graph (if 1d), or as a solid object (if 2d or 3d), or as a Schlegel diagram (4d).
Illustrate the behavior of a linear objective function on the polytope. Superpose the drawing with the directed graph induced by the objective function.
LinearProgram | lp | a Linear Program object attached to the polytope |
Visual::Polytope |
Illustrate the behavior of a linear objective function on the polytope. Draw the facets contained in MAXIMAL_FACE and MINIMAL_FACE in distinct colors.
LinearProgram | lp | a LinearProgram object attached to the polytope. |
Color | min | minimal face decoration (default: yellow vertices and/or facets) |
Color | max | maximal face decoration (default: red vertices and/or facets) |
Visual::Polytope |
Illustrate the behavior of a linear objective function on the polytope. Color the vertices according to the values of the objective function.
LinearProgram | lp | a LinearProgram object attached to the polytope |
Color | min | minimal vertex color (default: yellow) |
Color | max | maximal vertex color (default: red) |
Visual::Polytope |
Visualize the LATTICE_POINTS of a polytope
Visualize the LATTICE_POINTS of a polytope in different colors (interior / boundary / vertices)
Add the STEINER_POINTS to the 3-d visualization. The facets become transparent.
Add the triangulation to the drawing. The facets of the whole polytope become transparent.
You may specify any triangulation of the current polytope. Per default, the TRIANGULATION property is taken. (Currently there is only one possible alternative triangulation: TRIANGULATION_INT).
Hint: Use the method Method -> Effect -> Explode Group of Geometries of JavaView for better insight in the internal structure.
Array<Set<Int>> | TR | facets of the triangulation |
option list: | Visual::Polygons::decorations |
Visual::Polytope |
Draw the edges of the Polytope::TRIANGULATION_BOUNDARY. The facets are made transparent.
Visualization of the graph of a polyhedron.
Show the growth direction of a linear objective function via arrowed edges.
LinearProgram | lp | a LinearProgram object attached to the polytope |
Visual::PolytopeGraph |
produce an edge coloring of a bounded graph from local data in the Hasse diagram
Visual::PolytopeGraph |
Illustrate the behavior of a linear objective function on the polytope. The vertices belonging to MINIMAL_FACE and MAXIMAL_FACE are drawn in distinct colors
The spring embedder applies an additional force, which tries to arrange the nodes in the z-axis direction corresponding to the objective function values.
LinearProgram | lp | a LinearProgram object attached to the polytope |
Color | min | minimal face decoration (default: yellow nodes) |
Color | max | maximal face decoration (default: red nodes) |
Visual::PolytopeGraph |
Illustrate the behavior of a linear objective function on the polytope. Color the nodes according to the value the objective function takes on the vertices.
The spring embedder applies an additional force, which tries to arrange the nodes in the z-axis direction corresponding to the objective function values.
LinearProgram | lp | a LinearProgram object attached to the polytope. |
Color | min | minimal face color (default: yellow) |
Color | max | maximal face color (default: red) |
Visual::PolytopeGraph |
Visualization of the HASSE_DIAGRAM of a polyhedron as a multi-layer graph..
Illustrate the behavior of a linear objective function on the polytope. Draw the filters of the MAXIMAL_FACE and MINIMAL_FACE in distinct colors.
LinearProgram | lp | a LinearProgram object attached to the polytope |
Color | min | minimal face decoration (default: yellow border and ingoing edges) |
Color | max | maximal face decoration (default: red border and ingoing edges) |
Visual::PolytopeLattice |
Visualization of the Schlegel diagram of a polytope.
UNDOCUMENTED
option list: | Visual::PointSet::decorations |
Visualize the construction of a 3D Schlegel diagram, that is, the Viewpoint, the 3-polytope and the projection onto one facet
Illustrate the behavior of a linear objective function on the polytope. Superpose the drawing with the directed graph induced by the objective function.
LinearProgram | lp | a LinearProgram object attached to the polytope. |
Visual::SchlegelDiagram |
Illustrate the behavior of a linear objective function on the polytope. The vertices belonging to MINIMAL_FACE and MAXIMAL_FACE are drawn in distinct colors
LinearProgram | lp | a LinearProgram object attached to the polytope. |
Color | min | minimal face decoration (default: yellow vertices and/or facets) |
Color | max | maximal face decoration (default: red vertices and/or facets) |
Visual::SchlegelDiagram |
Draw the facets of the Schlegel diagram as polytopes.
Draw the edges of the TRIANGULATION_BOUNDARY
Draw the boundary simplices of the triangulation as solid tetrahedra
Illustrate the behavior of a linear objective function on the polytope. Color the vertices according to the values of the objective function.
LinearProgram | lp | a LinearProgram object attached to the polytope. |
Color | min | minimal vertex color (default: yellow) |
Color | max | maximal vertex color (default: red) |
Visual::SchlegelDiagram |
For a finite set of SITES S the Voronoi region of each site is the set of points closest (with respect to Euclidean distance) to the given site. All Voronoi regions (and their faces) form a polyhedral complex which is a vertical projection of the boundary complex of an unbounded polyhedron P(S). This way VoronoiDiagram becomes a derived class from Polytope<Rational>.
Delaunay triangulation of the sites. (Delaunay subdivision, non-simplices are triangulated.)
Graph of the joint Voronoi diagram of the SITES and the vertices of Vor(SITES). The coordinates (homogeneous, before projection) are stored as node attributes. The graph is truncated according to the VORONOI_GRAPH.BOUNDING_BOX. For the default BOUNDING_BOX it may happen that some of the iterated Voronoi vertices are truncated. Create new objects of type VoronoiDiagram to produce proper iterated Voronoi diagrams.
Graph of the nearest neighbor crust, as defined in:
T. K. Dey and P. Kumar: A simple provable algorithm for curve reconstruction.Proc. 10th. Annu. ACM-SIAM Sympos. Discrete Alg., 1999, 893-894.
Polygonal reconstruction of a smooth planar curve from a finite set of samples. Sampling rate of <= 1/3 suffices.
Graph of the nearest neighbors. This is a subgraph of NN_CRUST_GRAPH.
Coordinates of the sites in case the polyhedron is Voronoi. Sites must be pairwise distinct.
Graph of the Voronoi diagram of the SITES. The homogeneous coordinates after projection are stored as node attributes. The graph is truncated according to the BOUNDING_BOX. All vertices of the Voronoi diagram are visible (and represented in the VORONOI_GRAPH) for the default BOUNDING_BOX.
Draw a Voronoi diagram, its |dual graph and the crust. Use the interactive features of the viewer to select.
Draw a Voronoi diagram, its dual graph and the nearest neighbor crust. Use the interactive features of the viewer to select.
Draw a Voronoi diagram and its dual. Use the interactive features of the viewer to select.
Check whether two given polytopes P1 and P2 are congruent, i.e. whether there is an affine isomorphism between them that is induced by a (possibly scaled) orthogonal matrix. Returns the scale factor, or 0 if the polytopes are not congruent.
We are using the reduction of the congruence problem (for arbitrary point sets) to the graph isomorphism problem due to:
Akutsu, T.: On determining the congruence of point sets in `d` dimensions.Comput. Geom. Theory Appl. 9, 247--256 (1998), no. 4
Tests if the two polyhedra P1 and P2 are equal.
Find the permutations of facets and vertices which maps the polyhedron P1 to P2. The facet permutation is the first component of the return value.
Only the combinatorial isomorphism is considered. If the polytopes are not isomorphic, an exception is thrown.
Tests if polyhedron P1 is included in polyhedron P2.
Check whether the face lattices of two polytopes are isomorphic. The problem is reduced to graph isomorphism of the vertex-facet incidence graphs.
Tests whether two smooth lattice polytopes are lattice equivalent by comparing lattice distances between vertices and facets.
LatticePolytope | P1 | |
LatticePolytope | P2 |
Check coordinate data. For each pair of vectors from two given matrices their inner product must satisfy the given relation.
Try to check whether a given vertex-facet incidence matrix VIF defines a polytope. Note that a successful certification by check_poly is not sufficient to determine whether an incidence matrix actually defines a polytope. Think of it as a plausibility check.
IncidenceMatrix | VIF |
Bool | dual | transposes the incidence matrix |
Bool | verbose | prints information about the check. |
Polytope |
dehomogenize the vertex coordinates and convert them to Float
provide a Polytope object with desired coordinate type
Coord | target coordinate type |
Polytope | P | source object |
Polytope<Coord> |
P if it already has the requested type, a new object otherwise |
Compute the (a) Delaunay triangulation of the given SITES of a VoronoiDiagram V. If the sites are not in general position, the non-triangular facets of the Delaunay subdivision are triangulated (by applying the beneath-beyond algorithm).
Compute the inequalities of the Voronoi polyhedron of a given VoronoiDiagram V. The polyhedron is always unbounded. Introduce artificial cut facets later (e.g., for visualization); this must be done after the vertex have been computed.
Direct the graph of a polytope P according to a linear or abstract objective function. The maximal and minimal values, which are attained by the objective function, as well as the minimal and the maximal face are written into separate sections.
The option inverse directs the graph with decreasing instead of increasing edges. If the option generic is set, ties will be broken by lexicographical ordering.
Polytope | P | |
LinearProgram | LP |
Bool | inverse | inverts the direction |
Bool | generic | breaks ties |
Graph<Directed> |
Compute a true inner point of a convex hull of the given set of points.
Matrix | points |
Computes a vector containing the expected path length to the maximum for each vertex of a directed graph G. The random edge pivot rule is applied.
Produce a random abstract objective function on a given simple polytope P. It is assumed that the boundary complex of the dual polytope is extendibly shellable. If, during the computation, it turns out that a certain partial shelling cannot be extended, then this is given instead of an abstract objective function. It is possible (but not required) to specify the index of the starting vertex start.
Polytope | P | a simple polytope |
Int | start | the index of the starting vertex; default value: random |
Int | seed | controls the outcome of the random number generator;
fixing a seed number guarantees the same outcome. |
Array<Int> |
Computes a relative interior point of a polyhedron P and stores it in P->REL_INT_POINT. The unbounded flag needs to be set to true if the polyhedron could be unbounded.
Calculate RGB-color-values for each vertex depending on a linear or abstract objective function. Maximal and minimal affine vertices are colored as specified. Far vertices (= rays) orthogonal to the linear function normal vector are white. The colors for other affine vertices are linearly interpolated in the HSV color model.
If the objective function is linear and the corresponding LP problem is unbounded, then the affine vertices that would become optimal after the removal of the rays are painted pale.
Polytope | P | |
LinearProgram | LP |
RGB | min | the minimal RGB value |
RGB | max | the maximal RGB value |
Array<RGB> |
Compute the Steiner points of all faces of a polyhedron P using a randomized approximation of the angles. P must be BOUNDED.
Compute the Steiner point of a polyhedron P using a randomized approximation of the angles.
Algorithm to solve highly symmetric integer linear programs (ILP). It is required that the group of the ILP induces the alternating or symmetric group on the set of coordinate directions. The linear objective function is the vector (0,1,1,..,1).
Algorithm to solve symmetric linear programs (LP) of the form max ctx , c=(0,1,1,..,1) subject to the inequality system given by Inequalities. It is required that the symmetry group of the LP acts transitively on the coordinate directions.
Matrix | Inequalities | the inequalities describing the feasible region |
perl::ListReturn | (optLPsolution,optLPvalue,feasible,max_bounded) |
Returns a basis of the affine lattice spanned by the vertices
Computes the minimal angle between two vertices of the input polytope P.
Perturb a given input_matrix by adding a random matrix. The random matrix consists of vectors that are uniformly distributed on the unit sphere. Optionally, the random matrix can be scaled by a factor eps.
Matrix | input_matrix | |
Scalar | eps | the factor by which the random matrix is multiplied
default value: 1 |
Bool | not_hom | if set to 1, the first column will also be perturbed;
otherwise the first columns of the input_matrix and the perturbed one
coincide (useful for working with homogenized coordinates);
default value: 0 (homogen. coords) |
Int | seed | controls the outcome of the random number generator;
fixing a seed number guarantees the same outcome. |
Matrix |
Let G be a 3-connected planar graph. If the corresponding polytope contains a triangular facet (ie. the graph contains a non- separating cycle of length 3), the client produces a realization in R3.
Defines a very simple graph for a polytope propagation related to a Hidden Markov Model. The propagated polytope is always a polygon. For a detailed description see
M. Joswig: Polytope propagation, in: Algebraic statistics and computational biologyby L. Pachter and B. Sturmfels (eds.), Cambridge, 2005.
String | observation | encoded as a string of "0" and "1". |
Make a bipyramid over a polyhedron. The bipyramid is the convex hull of the input polyhedron P and two points (v, z), (v, z_prime) on both sides of the affine span of P. For bounded polyhedra, the apex projections v to the affine span of P coincide with the vertex barycenter of P.
Polytope | P | |
Rational | z | distance between the vertex barycenter and the first apex,
default value is 1. |
Rational | z_prime | distance between the vertex barycenter and the second apex,
default value is -z. |
Bool | noc | : don't compute the coordinates, purely combinatorial description is produced. |
Bool | relabel | copy the vertex labels from the original polytope,
label the new vertices with "Apex" and "Apex'". |
Compute the blending of two polyhedra at simple vertices. This is a slightly less standard construction. A vertex is simple if its vertex figure is a simplex.
Moving a vertex v of a bounded polytope to infinity yields an unbounded polyhedron with all edges through v becoming mutually parallel rays. Do this to both input polytopes P1 and P2 at simple vertices v1 and v2, respectively. Up to an affine transformation one can assume that the orthogonal projections of P1 and P2 in direction v1 and v2, respectively, are mutually congruent.
Any bijection b from the set of edges through v1 to the edges through v2 uniquely defines a way of glueing the unbounded polyhedra to obtain a new bounded polytope, the blending with respect to b. The bijection is specified as a permutation of indices 0 1 2 etc. The default permutation is the identity.
The number of vertices of the blending is the sum of the numbers of vertices of the input polytopes minus 2. The number of facets is the sum of the numbers of facets of the input polytopes minus the dimension.
The resulting polytope is described only combinatorially.
Create a Cayley embedding of two polytopes. The vertices of the first polytope P get an extra coordinate z and the vertices of the second polytope P_prime get z_prime.
Default values are z=1 and z_prime=-z.
The option relabel creates an additional section VERTEX_LABELS. The vertices of P inherit the original labels unchanged; the vertex labels of P_prime get a tick (') appended.
Construct the cayley polytope of a set of lattice polytopes contained in P_Array which is the convex hull of P1×e1, ..., Pk×ek where e1, ...,ek are the standard unit vectors in Rk. In this representation the last k coordinates always add up to 1. The option proj projects onto the complement of the last coordinate.
Array<LatticePolytope> | P_Array | an array containing the lattice polytopes P1,...,Pk
|
Bool | proj |
Polytope |
Extract the given cells of the subdivision of a polyhedron and write their union as a new polyhedron.
Extract the given cell of the subdivision of a polyhedron and write it as a new polyhedron.
Construct a new polyhedron as the convex hull of the polyhedra given in P_Array.
Produce the convex hull of all edge middle points of some polytope P. The polytope must be BOUNDED.
Extract the given facet of a polyhedron and write it as a new polyhedron.
Make an affine transformation such that the i-th facet is transformed to infinity
Construct a new polyhedron as the intersection of given polyhedra.
Construct a new polyhedron as the join of two given ones.
Make a lattice bipyramid over a polyhedron. The bipyramid is the convex hull of the input polyhedron P and two points (v, z), (v_prime, z_prime) on both sides of the affine span of P.
Polytope | P | |
Vector | v | basis point for the first apex |
Vector | v_prime | basis for the second apex
If v_prime is omitted, v will be used for both apices.
If both v and v_prime are omitted, it tries to find two vertices which don't lie in a common facet.
If no such vertices can be found or P is a simplex, it uses an interior lattice point as
both v and v_prime. |
Rational | z | height for the first apex, default value is 1 |
Rational | z_prime | hieght for the second apex, default value is -z
|
Bool | relabel | copy the vertex labels from the original polytope,
label the new vertices with "Apex" and "Apex'". |
Polytope |
Make a lattice pyramid over a polyhedron. The pyramid is the convex hull of the input polyhedron P and a point v outside the affine span of P.
Construct a new polytope as the mapping polytope of two polytopes P1 and P2. The mapping polytope is the set of all affine maps from Rp to Rq, that map P1 into P2.
The label of a new facet corresponding to v1 and h1 will have the form "v1*h1".
Produces the polytope lambda*P1+mu*P2, where * and + are scalar multiplication and Minkowski addition, respectively.
Produces the Minkowski sum of P1 and P2.
Make a prism over a polytope. The prism is the product of the input polytope P and the interval [z1, z2].
Polytope | P | the input polytope |
Rational | z1 | the left endpoint of the interval; default value: -1 |
Rational | z2 | the right endpoint of the interval; default value: -z1
|
Bool | noc | only combinatorial information is handled |
Bool | relabel | creates an additional section VERTEX_LABELS;
the bottom facet vertices get the labels from the original polytope;
the labels of their clones in the top facet get a tick (') appended. |
Polytope |
Construct a new polytope as the product of two given polytopes P1 and P2.
Orthogonally project a polyhedron to a coordinate subspace.
The subspace the polyhedron P is projected on is given by the coordinate indices in the set indices. The option revert inverts the coordinate list. The client scans for all coordinate sections and produces proper output from each. If a description in terms of inequalities is found, the client performs Fourier-Motzkin elimination unless the nofm option is set. Setting the nofm option is useful if the corank of the projection is large; in this case the number of inequalities produced grows quickly.
Polytope | P | |
Array<Int> | indices |
Bool | revert | inverts the coordinate list |
Bool | nofm | suppresses Fourier-Motzkin elimination |
Polytope |
Orthogonally project a polyhedron to a coordinate subspace such that "redundant" columns are omitted, i.e., the projection becomes full-dimensional without changing the combinatorial type. The client scans for all coordinate sections and produces proper output from each. If a description in terms of inequalities is found, the client performs Fourier-Motzkin elimination unless the nofm option is set. Setting the nofm option is useful if the corank of the projection is large; in this case the number of inequalities produced grows quickly.
Make a pyramid over a polyhedron. The pyramid is the convex hull of the input polyhedron P and a point v outside the affine span of P. For bounded polyhedra, the projection of v to the affine span of P coincides with the vertex barycenter of P.
Polytope | P | |
Rational | z | is the distance between the vertex barycenter and v,
default value is 1. |
Bool | noc | don't compute new coordinates, produce purely combinatorial description. |
Bool | relabel | copy vertex labels from the original polytope,
label the new top vertex with "Apex". |
Polytope |
Produce a polytope with n random points from the input polytope P. Each generated point is a convex linear combination of the input vertices with uniformly distributed random coefficients. Thus, the output points can't in general be expected to be distributed uniformly within the input polytope; cf. unirand for this. The polytope must be BOUNDED.
Selects n random vertices from the set of vertices V. This can be used to produce random polytopes which are neither simple nor simplicial as follows: First produce a simple polytope (for instance at random, by using rand_sphere, rand, or unirand). Then use this client to choose among the vertices at random. Generalizes random 0/1-polytopes.
Stack a (simplicial or cubical) polytope over one or more of its facets.
For each facet of the polytope P specified in stack_facets, the barycenter of its vertices is lifted along the normal vector of the facet. In the simplicial case, this point is directly added to the vertex set, thus building a pyramid over the facet. In the cubical case, this pyramid is truncated by a hyperplane parallel to the original facet at its half height. This way, the property of being simplicial or cubical is preserved in both cases.
The option lift controls the exact coordinates of the new vertices. It should be a rational number between 0 and 1, which expresses the ratio of the distance between the new vertex and the stacked facet, to the maximal possible distance. When lift=0, the new vertex would lie on the original facet. lift=1 corresponds to the opposite extremal case, where the new vertex hit the hyperplane of some neighbor facet. As an additional restriction, the new vertex can't lie further from the facet as the vertex barycenter of the whole polytope. Alternatively, the option noc (no coordinates) can be specified to produce a pure combinatorial description of the resulting polytope.
Polytope | P | |
Set<Int> | stack_facets | the facets to be stacked;
A single facet to be stacked is specified by its number.
Several facets can be passed in a Set or in an anonymous array of indices: [n1,n2,...]
Special keyword All means that all factes are to be stacked. |
Rational | lift | controls the exact coordinates of the new vertices;
rational number between 0 and 1; default value: 1/2 |
Bool | noc | produces a pure combinatorial description (in contrast to lift) |
Bool | relabel | creates an additional section VERTEX_LABELS;
New vertices get labels 'f(FACET_LABEL)' in the simplicial case,
and 'f(FACET_LABEL)-NEIGHBOR_VERTEX_LABEL' in the cubical case. |
Polytope |
Perform a stellar subdivision of all proper faces, starting with the facets.
Parameter d specifies the lowest dimension of the faces to be divided. It can also be negative, then treated as the co-dimension. Default is 1, that is, the edges of the polytope.
Perform a stellar subdivision of the faces in_faces of a polyhedron P.
The faces must have the following property: The open vertex stars of any pair of faces must be disjoint.
Cut off one or more vertices of a polyhedron.
The exact location of the cutting hyperplane(s) can be controlled by the option cutoff, a rational number between 0 and 1. When cutoff=0, the hyperplane would go through the chosen vertex, thus cutting off nothing. When cutoff=1, the hyperplane touches the nearest neighbor vertex of a polyhedron.
Alternatively, the option noc (no coordinates) can be specified to produce a pure combinatorial description of the resulting polytope, which corresponds to the cutoff factor 1/2.
Polytope | P | |
Set<Int> | trunc_vertices | the vertex/vertices to be cut off;
A single vertex to be cut off is specified by its number.
Several vertices can be passed in a Set or in an anonymous array of indices: [n1,n2,...]
Special keyword All means that all vertices are to be cut off. |
Rational | cutoff | controls the exact location of the cutting hyperplane(s);
rational number between 0 and 1; default value: 1/2 |
Bool | noc | produces a pure combinatorial description (in contrast to cutoff) |
Bool | relabel | creates an additional section VERTEX_LABELS;
New vertices get labels of the form 'LABEL1-LABEL2', where LABEL1 is the original label
of the truncated vertex, and LABEL2 is the original label of its neighbor. |
Polytope |
Produce a polytope with n random points that are uniformly distributed within the given polytope P. P must be full-dimensional.
Construct the vertex figure of the vertex n of a polyhedron. The vertex figure is dual to a facet of the dual polytope.
Polytope | p | |
Int | n | number of the chosen vertex |
Rational | cutoff | controls the exact location of the cutting hyperplane.
It should lie between 0 and 1.
Value 0 would let the hyperplane go through the chosen vertex,
thus degenerating the vertex figure to a single point.
Value 1 would let the hyperplane touch the nearest neighbor vertex of a polyhedron.
Default value is 1/2. |
Bool | noc | skip the coordinates computation, producing a pure combinatorial description. |
Bool | relabel | inherit vertex labels from the corresponding neighbor vertices of the original polytope. |
Polytope |
Make a wedge from a polytope over the given facet. The polytope must be bounded. The inclination of the bottom and top side facet is controlled by z and z_prime, which are heights of the projection of the old vertex barycenter on the bottom and top side facet respectively.
Polytope | P | |
Int | facet | the `cutting edge'. |
Rational | z | default value is 0. |
Rational | z_prime | default value is -z, or 1 if z==0. |
Bool | noc | don't compute coordinates, pure combinatorial description is produced. |
Bool | relabel | create vertex labels:
The bottom facet vertices obtain the labels from the original polytope;
the labels of their clones in the top facet get a tick (') appended. |
Polytope |
Cut polytope of an undirected graph.
Matching polytope of an undirected graph.
Produce a d-dimensional associahedron (or Stasheff polytope). We use the facet description given in Ziegler's book on polytopes, section 9.2.
Create the 24-cell polytope.
Polytope |
Create the 600-cell polytope. Cf. Coxeter, Introduction to Geometry, pp 403-404.
Polytope |
Produce a d-dimensional cube. Regular polytope corresponding to the Coxeter group of type Bd-1 = Cd-1.
The bounding hyperplanes are xi <= x_up and xi >= x_low. Default values: x_up=1, x_low=-x_up or 1 if x_up==0.
Produce a d-dimensional cyclic polytope with n points. Prototypical example of a neighborly polytope. Combinatorics completely known due to Gale's evenness criterion. Coordinates are chosen on the moment curve at integer steps from start, or 0 if not specified.
Produce a d-dimensional cyclic polytope with n points. Prototypical example of a neighborly polytope. Combinatorics completely known due to Gale's evenness criterion. Coordinates are chosen on the trigonometric moment curve.
Produce a d-dimensional dwarfed cube.
Produce a d-dimensional dwarfed product of polygons of size s.
Produces a d-dimensional Goldfarb cube if e<1/2 and g<=e/4. The Goldfarb cube is a combinatorial cube and yields a bad example for the Simplex Algorithm using the Shadow Vertex Pivoting Strategy. Here we use the description as a deformed product due to Amenta and Ziegler. For e<1/2 and g=0 we obtain the Klee-Minty cubes.
Produce the hypersimplex Δ(k,d), that is the the convex hull of all 0/1-vector in Rd with exactly k 1s. Note that the output is never full-dimensional.
Produce a d-dimensional hypertruncated cube. With symmetric linear objective function (0,1,1,...,1).
Produce a knapsack polytope defined by one linear inequality (and non-negativity constraints).
Produce a (rounded) 2*k-dimensional k-cyclic polytope with n points, where k is the length of the input vector s. Special cases are the bicyclic (k=2) and tricyclic (k=3) polytopes. Only possible in even dimensions.
The parameters s_i can be specified as integer, floating-point, or rational numbers. The coordinates of the i-th point are taken as follows:
cos(s_1 * 2πi/n),sin(s_1 * 2πi/n),...cos(s_k * 2πi/n),sin(s_k * 2πi/n)
Warning: Some of the k-cyclic polytopes are not simplicial. Since the components are rounded, this function might output a polytope which is not a k-cyclic polytope!
More information can be found in the following references:
P. Schuchert: "Matroid-Polytope und Einbettungen kombinatorischer Mannigfaltigkeiten",PhD thesis, TU Darmstadt, 1995.
Z. Smilansky: "Bi-cyclic 4-polytopes",Isr. J. Math. 70, 1990, 82-92
Produce a d-dimensional polytope of maximal Gomory-Chvatal rank Omega(d/log(d)), integrally infeasible. With symmetric linear objective function (0,1,1..,1). Construction due to Pokutta and Schulz.
Produce a combinatorial description of a multiplex with parameters d and n. This yields a self-dual d-dimensional polytope with n+1 vertices.
They are introduced by
T. Bisztriczky,On a class of generalized simplices, Mathematika 43:27-285, 1996,
see also
M.M. Bayer, A.M. Bruening, and J.D. Stewart,A combinatorial study of multiplexes and ordinary polytopes,Discrete Comput. Geom. 27(1):49--63, 2002.
Produce the combinatorial description of a neighborly cubical polytope. The facets are labelled in oriented matroid notation as in the cubical Gale evenness criterion.
See Joswig and Ziegler, Discr. Comput. Geom. 24:315-344 (2000).
Produce the Newton polytope of a polynomial p.
Produce a d-dimensional permutahedron. The vertices correspond to the elements of the symmetric group of degree d+1.
Produce a (d+1)-dimensional polytope from a pile of cubes. Start with a d-dimensional pile of cubes. Take a generic convex function to lift this polytopal complex to the boundary of a (d+1)-polytope.
Vector<Int> | sizes | a vector (s1,...,sd,
where si specifies the number of boxes in the i-th dimension. |
Polytope |
Produce a d-dimensional 0/1-polytope with n random vertices. Uniform distribution.
Computes the convex hull of n points sampled uniformly at random from the integer points in the cube [0,b]d.
Produce an n-point metric with random distances. The values are uniformily distributed in [1,2].
Produce a d-dimensional polytope with n random vertices uniformly distributed on the unit sphere.
Produce a polytope of constrained expansions in dimension l according to
Rote, Santos, and Streinu: Expansive motions and the polytope of pointed pseudo-triangulations.Discrete and computational geometry, 699--736, Algorithms Combin., 25, Springer, Berlin, 2003.
Produce a d-dimensional signed permutahedron.
Produce the standard d-simplex. Combinatorially equivalent to a regular polytope corresponding to the Coxeter group of type Ad-1. Optionally, the simplex can be scaled by the parameter scale.
Produce the transportation polytope from two vectors r of length m and c of length n, i.e. all positive m×n Matrizes with row sums equal to r and column sums equal to c.
Create a point configuration as a barycentric subdivision of a given one.
PointConfiguration | pc | input point configuration |
Bool | no_labels | do not write any labels |
PointConfiguration |
Computes the common refinement of two subdivisions of points. It is assumed that there exists a common refinement of the two subdivisions.
Matrix | points | |
Array<Set> | sub1 | first subdivision |
Array<Set> | sub2 | second subdivision |
Int | dim | dimension of the point configuration |
Array<Set<Int>> | the common refinement |
Computes the common refinement of two subdivisions of the same polytope p1, p2. It is assumed that there exists a common refinement of the two subdivisions. It is not checked if p1 and p2 are indeed the same!
Checks whether faces forms a valid subdivision of points, where points is a set of points, and faces is a collection of subsets of (indices of) points. If the set of interior points of points is known, this set can be passed by assigning it to the option interior_points. If points are in convex position (i.e., if they are vertices of a polytope), the option interior_points should be set to [ ] (the empty set).
Compute the placing triangulation of the given point set using the beneath-beyond algorithm.
Compute a regular subdivision of the polytope obtained by lifting points to weights and taking the lower complex of the resulting polytope. If the weight is generic the output is a triangulation.
Tests which of the splits of a polyhedron are coarsenings of the given subdivision.
Matrix | vertices | the vertices of the polyhedron |
Array<Set<Int>> | subdivision | a subdivision of the polyhedron |
Matrix | splits | the splits of the polyhedron |
Set<Int> |
DOC_FIXME: Incomprehensible description! Computes the compatibility graph among the splits of a polytope P.
Computes the split polyhedron of a full-dimensional polyhdron P.
Gives a weight vector for the staircase triangulation of the product of a k- and an l-dimensional simplex.
Int | k | the dimension of the first simplex |
Int | l | the dimension of the second simplex |
Vector<Rational> |
Computes the complex obtained by stellar subdivision of all faces of the TRIANGULATION of the PointConfiguration.
PointConfiguration | pc | input point configuration |
Array<Set<Int>> | faces | list of faces to subdivide |
Bool | no_labels | : do not write any labels |
PointConfiguration |
Compute the tight span dual to the regular subdivision obtained by lifting points to weight and taking the lower complex of the resulting polytope.
Compute the tight span dual to the regular subdivision of a polytope P obtained by the WEIGHTS and taking the lower complex of the resulting polytope.
Compute a metric such that the f-vector of its tight span is maximal among all metrics with n points.
S. Herrmann and M. Joswig: Bounds on the f-vectors of tight spans.Contrib. Discrete Math., Vol.2, 2007 161-184
Given a generic finite metric space FMS, construct the associated (i.e. dual) triangulation of the hypersimplex.
Computes the split decomposition of a metric space D (encoded as a symmetric distance matrix).
Compute a metric such that the f-vector of its tight span is minimal among all metrics with n points.
S. Herrmann and M. Joswig: Bounds on the f-vectors of tight spans.Contrib. Discrete Math., Vol.2, 2007 161-184
Define a metric by restricting the Euclidean distance function to the vertex set of a given polytope P. Due to floating point computations (sqrt is used) the metric defined may not be exact. If the option max or l1 is set to true the max-norm or l1-nomr is used instead (with exact computation).
Compute a metric such that the f-vector of its tight span is maximal among all metrics with n points. This metric can be interpreted as a lifting function for the thrackle triangulation (see de Loera, Sturmfels and Thomas: Groebner Basis and triangultaions of the second hypersimplex)
Computes the tight span of a metric such that its f-vector is maximal among all metrics with n points.
S. Herrmann and M. Joswig: Bounds on the f-vectors of tight spans.Contrib. Discrete Math., Vol.2, 2007 161-184
Compute the tight span of a metric such its f-vector is minimal among all metrics with n points.
S. Herrmann and M. Joswig: Bounds on the f-vectors of tight spans.Contrib. Discrete Math., Vol.2, 2007 161-184
Compute a tight span of a metric such that its f-vector is maximal among all metrics with n points. This metric can be interpreted as a lifting function for the thrackle triangulation (see de Loera, Sturmfels and Thomas: Groebner Basis and triangultaions of the second hypersimplex)
Transform to a full-dimensional polytope while preserving the ambient lattice Z^n
Transform to a full-dimensional polytope while preserving the lattice spanned by vertices induced lattice of new vertices = Z^dim
Make a positive polyhedron bounded. Apply a projective linear transformation to a polyhedron mapping the far hyperplane to the hyperplane spanned by the points (1,0,...,0,1,0,...). The origin (1,0,...,0) is fixed.
The input polyhedron should be POSITIVE; i.e. no negative coordinates.
Make a polyhedron POSITIVE. Apply an affine transformation to a polyhedron such that the vertex v is mapped to the origin (1,0,...,0) and as many facets through this vertex as possible are mapped to the bounding facets of the first orthant.
Apply a reverse transformation to a given polyhedron P. All transformation clients keep track of the polytope's history. They write or update the attachment REVERSE_TRANSFORMATION.
Applying revert to the transformed polytope reconstructs the original polyhedron.
Transform a polyhedron P according to the linear transformation trans.
Translate a polyhedron P by a given translation vector trans.
Read a linear programming problem given in LP-Format (as used by cplex & Co.) and convert it to a Polytope<Float> object
String | file | filename of a linear programming problem in LP-Format |
Polytope<Float> |
Convert a polymake description of a polyhedron to LP format (as used by CPLEX and other linear problem solvers) and write it to standard output or to a file. If LP comes with an attachment 'INTEGER_VARIABLES' (of type Array<Bool>), the output will contain an additional section 'GENERAL', allowing for IP computations in CPLEX.
Polytope | P | |
LinearProgram | LP | default value: P->LP |
Bool | maximize | produces a maximization problem; default value: 0 (minimize) |
String | file | default value: standard output |
Read an .ieq or .poi file (porta input) or .poi.ieq or .ieq.poi (porta output) and convert it to a Polytope<Rational> object
Write the face lattice of a vertex-facet incidence matrix VIF to stdout. If dual is set true the face lattice of the dual is printed.
IncidenceMatrix | VIF | |
Bool | dual |
Introduce artificial boundary facets (which are always vertical, i.e., the last coordinate is zero) to allow for bounded images of unbounded polyhedra (e.g. Voronoi polyhedra). If the voronoi flag is set, the last direction is left unbounded.
Clip a graph with respect to a given bounding box. Used for the visualization of Voronoi diagrams.
Call wiki:external_software#SplitsTree with the given visual objects.
Visual::Object | vis_obj ... | objects to display |
String | File | "filename" or "AUTO"
Only create a NEXUS format file, don't start the GUI.
The
.nex suffix is automatically added to the file name. Specify AUTO if you want the filename be automatically derived from the drawing title.
You can also use any expression allowed for the
open function,
including "-" for terminal output, "&HANDLE" for an already opened file handle,
or "| program" for a pipe. |
Initial properties of the Schlegel diagram to be displayed.
Int | FACET | index of the projection facet, see SchlegelDiagram::FACET
|
Rational | ZOOM | zoom factor, see SchlegelDiagram::ZOOM
|
Vector | FACET_POINT | |
Vector | INNER_POINT |