GraphDataCopy to clipboard.
✖
GraphData
Details




- The specified entity in GraphData can be an Entity, a list of entities or an entity canonical name such as such as "PetersenGraph" or "FosterCage".
- GraphData[entity] gives a Graph object.
- The specified property can be an EntityProperty, a property canonical name or a list of properties.
- GraphData[patt] gives a list of all graph standard names that match the string pattern patt.
- GraphData[] gives a list of all standard named graphs.
- GraphData[All] gives all available graphs.
- GraphData[;;n] gives a list of available standard named graphs with ≤n vertices.
- GraphData[m;;n] gives a list of available standard named graphs with m through n vertices.
- GraphData[class,nspec] gives a list of available graphs with nspec vertices in the specified class.
- GraphData["Classes"] gives a list of all supported classes.
- GraphData["Properties"] gives a list of properties available for graphs.
- GraphData[{n,i},…] gives data for the i
simple graph with n vertices.
- GraphData[{"type",id},…] gives data for the graph of the specified type with identifier id. The type is typically a string and the identifier is typically an integer or lists of integers.
- Basic graph properties include:
-
"AdjacencyMatrix" adjacency matrix "EdgeCount" total number of edges "Edges" edges "FaceCount" total number of faces (for a planar graph) "Faces" faces "IncidenceMatrix" incidence matrix "VertexCount" total number of vertices "Vertices" vertices - Properties related to graph connectivity include:
-
"AdjacencyLists" adjacency lists "ArticulationVertexCount" number of articulation vertices "ArticulationVertices" list of vertices whose removal would disconnect the graph "BlockCount" number of blocks "Blocks" minimal 2-connected components "BridgeCount" number of bridges "Bridges" list of edges whose removal would disconnect the graph "Connected" connected "ConnectedComponentCount" number of connected components "ConnectedInducedSubgraphCount" connected induced subgraph count "ConnectedComponents" connected components "CyclicEdgeConnectivity" cyclic edge connectivity "Disconnected" disconnected "EdgeConnectivity" minimum edge deletions to disconnect the graph "EdgeCutCount" number of edge cuts "EdgeCuts" edge cuts "IncidenceLines" indices of collinear vertices in a configuration graph "LambdaComponents" lambda components "LuccioSamiComponents" Luccio–Sami components "MinimalEdgeCutCount" number of minimal edge cuts "MinimalEdgeCuts" minimal edge cuts "MinimalVertexCutCount" number of minimal vertex cuts "MinimalVertexCuts" minimal vertex cuts "MinimumCyclicEdgeCutCount" minimum cyclic edge cut count "MinimumCyclicEdgeCuts" minimum cyclic edge cuts "MinimumEdgeCutCount" number of minimum edge cuts "MinimumEdgeCut" minimum edge cuts "MinimumVertexCutCount" minimum vertex cut count "MinimumVertexCuts" minimum vertex cuts "MinorCount" graph minor count "SpanningTrees" spanning trees "Strength" graph strength "Toughness" graph toughness "Triangulated" triangulated (maximally planar) "VertexConnectivity" minimum vertex deletions to disconnect the graph - Properties related to graph minors include:
-
"HadwigerNumber" Hadwiger number "MinorCount" graph minor count - Properties related to graph display include:
-
"EmbeddingClasses" list of embedding class tags, one to an embedding "Embeddings" vertex coordinates for all available layouts "Graph" graph object "Graphics" graphic "Graphics3D" 3D graphics "Image" image "MeshRegion" mesh region "Polyhedron" polyhedron "VertexCoordinates" vertex coordinates for the default layout - Annotatable properties related to list-type output include:
-
"AdjacencyMatrix","outputtype" one or all adjacency matrices or count of all possible adjacency matrices "ConnectedComponents","outputtype" connected components as a graph, list, count, list of edge counts, or list of vertex counts "Cycles","outputtype" undirected, directed, or count of cycles "Edges","outputtype" edges as a list, edge list, index pair list, rule list, graphic, or count of edges "EulerianCycles","outputtype" undirected, directed, or count of Eulerian cycles "Faces","outputtype" faces as a list, index list, graphic, or count of faces "HamiltonianCycles","outputtype" undirected, directed, or count of Hamiltonian cycles "HamiltonianPaths","outputtype" undirected, directed, or count of Hamiltonian paths "HamiltonianWalks","outputtype" undirected, directed, or count of Hamiltonian walks "VertexCoordinates","outputtype" one or all vertex coordinates or embedding count "Vertices","outputtype" vertices as a list, indexed coordinate rule list, graphic, or count of vertices - Properties giving pure functions representing graph polynomials include:
-
"CharacteristicPolynomial" characteristic polynomial of the adjacency matrix "ChordlessCyclePolynomial" polynomial encoding the counts of chordless cycles by length "ChromaticPolynomial" chromatic polynomial "CliquePolynomial" clique polynomial "CoboundaryPolynomial" coboundary polynomial "ComplementChordlessCyclePolynomial" polynomial encoding the counts of chordless cycles in the graph complement by length "ComplementOddChordlessCyclePolynomial" polynomial encoding the counts of odd chordless cycles in the graph complement by length "ConnectedDominationPolynomial" connected domination polynomial "ConnectedInducedSubgraphPolynomial" polynomial encoding the counts of connected induced subgraphs by size "CyclePolynomial" cycle polynomial "DetourPolynomial" characteristic polynomial of the detour matrix "DistancePolynomial" distance polynomial "DominationPolynomial" domination polynomial "EdgeCoverPolynomial" edge cover polynomial "EdgeCutPolynomial" edge cut polynomial "FlowPolynomial" flow polynomial "IdiosyncraticPolynomial" Tutte's idiosyncratic polynomial "IndependencePolynomial" independence polynomial "IrredundancePolynomial" irredundance polynomial "LaplacianPolynomial" Laplacian polynomial "MatchingGeneratingPolynomial" matching generating polynomial "MatchingPolynomial" matching polynomial "MaximalCliquePolynomial" polynomial encoding the counts of maximal cliques by size "MaximalIndependencePolynomial" polynomial encoding the counts of maximal independent vertex sets by size "MaximalIrredundancePolynomial" polynomial encoding the counts of maximal irredundant sets by size "MaximalMatchingGeneratingPolynomial" polynomial encoding the counts of maximal independent edge sets by size "MinimalConnectedDominationPolynomial" polynomial encoding the counts of minimal connected dominating sets by size "MinimalDominationPolynomial" polynomial encoding the counts of minimal dominating sets by size "MinimalEdgeCoverPolynomial" polynomial encoding the counts of minimal edge covers by size "MinimalEdgeCutPolynomial" polynomial encoding the counts of minimal edge cuts by size "MinimalTotalDominationPolynomial" polynomial encoding the counts of minimal total dominating sets by size "MinimalVertexCoverPolynomial" polynomial encoding the counts of minimal vertex covers by size "MinimalVertexCutPolynomial" polynomial encoding the counts of minimal vertex cuts by size "OddChordlessCyclePolynomial" polynomial encoding the counts of odd chordless cycles by length "PathPolynomial" path polynomial "QChromaticPolynomial" Q-chromatic polynomial "RankPolynomial" rank polynomial "ReliabilityPolynomial" reliability polynomial "SigmaPolynomial" chromatic polynomial in falling factorial basis "TotalDominationPolynomial" polynomial encoding the counts of total dominating sets by size "TuttePolynomial" Tutte polynomial "VertexCoverPolynomial" polynomial encoding the counts of vertex covers by size "VertexCutPolynomial" polynomial encoding the counts of vertex cuts by size - Coloring‐related graph properties include:
-
"ChromaticInvariant" chromatic invariant "ChromaticNumber" chromatic number "ChromaticPolynomial" chromatic polynomial "ChromaticRoots" chromatic roots "CyclicChromaticNumber" cyclic chromatic number "EdgeChromaticNumber" edge chromatic number "FractionalChromaticNumber" fractional chromatic number "FractionalEdgeChromaticNumber" fractional edge chromatic number "MinimumVertexColoringCount" number of minimum vertex colorings "MinimumVertexColorings" minimum vertex colorings "MinimumEdgeColoring" minimum edge coloring "MinimumWeightFractionalColoring" minimum weight fractional coloring "QChromaticPolynomial" Q‐chromatic polynomial "WeisfeilerLemanDimension" Weisfeiler–Leman dimension - Graph index properties include:
-
"ABCIndex" atom-bond connectivity index "ArithmeticGeometricIndex" arithmetic-geometric index "BalabanIndex" Balaban index "CircuitRank" minimum number of edges to remove to turn acyclic "DetourIndex" detour index "HararyIndex" Harary index "HosoyaIndex" Hosoya index "KirchhoffIndex" Kirchhoff index "KirchhoffSumIndex" Kirchhoff sum index "MolecularTopologicalIndex" molecular topological (second Schultz) index "RandicIndex" Randić index "SomborIndex" Sombor index "StabilityIndex" stability index "TopologicalIndex" topological (first Schultz) index "WienerIndex" Wiener index "WienerSumIndex" Wiener sum index "ZagrebIndex1" first Zagreb index "ZagrebIndex2" second Zagreb index - Matrix graph properties include:
-
"ABCMatrix" atom-bond connectivity matrix "AdjacencyMatrix" adjacency matrix "ArithmeticGeometricMatrix" arithmetic-geometric matrix "DetourMatrix" matrix of longest path distances "DistanceMatrix" distance matrix "IncidenceMatrix" incidence matrix "LaplacianMatrix" Laplacian matrix "MaximumFlowMatrix" matrix flow matrix "MinimumCostFlowMatrix" minimum cost flow matrix "NormalizedLaplacianMatrix" normalized Laplacian matrix "RandicMatrix" Randić matrix "ResistanceMatrix" resistances between pairs of vertices for unit‐resistance edges "SomborMatrix" Sombor matrix - Local graph properties include:
-
"ChordCount" number of chords "Chords" chords "Curvatures" curvatures "IsolatedPointCount" number of isolated points "IsolatedPoints" vertices of degree 0 "LeafCount" number of leaves "Leaves" vertices of degree 1 - Global graph properties include:
-
"Anarboricity" maximum number of edge‐disjoint nonacyclic subgraphs whose union is the original graph "ApexCount" apex count "Apices" list of vertices whose removal renders the graph planar "Arboricity" minimum number of edge‐disjoint acyclic subgraphs whose union is the original graph "Center" indices of vertices with graph eccentricity equal to radius "Circumference" circumference of the graph "Coarseness" maximum number of line‐disjoint nonplanar subgraphs "Corank" edge count minus vertex count plus connected component count "Degeneracy" graph degeneracy "DegreeSequence" vertex degrees in monotonic nonincreasing order "DeterminedByResistance" no other graph shares the same multiset of resistances "DeterminedBySpectrum" no other graph shares the spectrum "Diameter" diameter of the graph "Eccentricities" eccentricities of each vertex "FractionalArboricity" fractional arboricity "IntersectionArray" intersection array "LinearArboricity" linear arboricity "MaximumLeafNumber" largest number of tree leaves in any spanning trees "MaximumVertexDegree" largest vertex degree "MeanCurvature" mean curvature "MeanDistance" mean distance between vertices "MinimumLeafNumber" smallest number of tree leaves in any spanning trees "MinimumVertexDegree" smallest vertex degree "Periphery" indices of vertices with graph eccentricity equal to diameter "Pseudoarboricity" pseudoarboricity "QuadraticEmbeddingConstant" quadratic embedding constant "Rank" vertex count minus connected component count "RegularParameters" parameters describing common neighbor counts of vertices "Skewness" minimum number of edges whose removal would result in a planar graph "SpanningTreeCount" number of spanning trees "StarArboricity" star arboricity "Thickness" minimum number of planar subgraphs whose union is the original graph "TreeNumber" minimal number of trees covering the edges of a graph "Triameter" graph triameter (generalization of graph diameter) "VertexDegrees" vertex degeres - Spectral graph properties include:
-
"ABCEnergy" atom-bond connectivity energy "ABCSpectralRadius" atom-bond connectivity spectral radius "AlgebraicConnectivity" second smallest eigenvalue of the Laplacian matrix "ArithmeticGeometricEnergy" arithmetic-geometric energy "ArithmeticGeometricSpectralRadius" arithmetic-geometric spectral radius "Energy" graph energy "LaplacianSpectralRadius" Laplacian spectral radius "LaplacianSpectralRatio" Laplacian spectral ratio "LaplacianSpectrum" eigenvalues of the Laplacian matrix "RandicEnergy" Randić energy "SomborEnergy" Sombor energy "SomborSpectralRadius" Sombor spectral radius "SpectralRadius" spectral radius "Spectrum" eigenvalues of the adjacency matrix "SpectrumSignature" tallies of adjacency matrix eigenvalues - Labeled graph properties include:
-
"AverageDisorderNumber" average disorder number "DisorderNumber" disorder number "ErdosSequence" Erdős sequence "GracefulLabelingCount" number of fundamentally distinct graceful labelings "GracefulLabelings" fundamentally distinct graceful labelings "IrregularityStrength" irregularity strength "PinnacleSetCount" number of pinnacle sets "PinnacleSets" pinnacle sets "RadioLabelingCount" number of fundamentally distinct optimal radio labelings "RadioLabelings" fundamentally distinct optimal radio labelings "RadioNumber" radio number - Graph construction properties include:
-
"AssemblyNumber" assembly number "ConstructionNumber" construction number - Topological graph properties include:
-
"CrossingNumber" minimum crossings in an embedding of the graph "Dimension" graph dimension "Genus" minimum number of handles yielding a non-edge-crossing embedding "KleinBottleCrossingNumber" minimum crossings in a Klein bottle embedding "LocalCrossingNumber" local crossing number "MapNumber" map number "MetricDimension" metric dimension "ProjectivePlaneCrossingNumber" minimum crossings in a projective plane embedding "RectilinearCrossingNumber" minimum crossings in a straight‐line embedding "RectilinearLocalCrossingNumber" rectilinear local crossing number "ToroidalCrossingNumber" minimum crossings in a toroidal embedding - Clique‐related properties include:
-
"CliquePolynomial clique polynomial "Cliques cliques "BicliqueNumber" biclique number "BipartiteDimension" bipartite dimension "CliqueCount" number of cliques "CliqueCoveringNumber" minimum number of maximum cliques needed to cover the vertex set "CliqueNumber" number of vertices in a maximum clique "DelsarteCliqueCount" number of Delsarte cliques "DelsarteCliques cliques in a distance-regular graph for which the Delsarte bound is achieved "FractionalCliqueNumber" fractional clique number "LowerCliqueNumber" size of smallest maximal clique "MaximalCliqueCount" number of distinct maximal cliques "MaximalCliquePolynomial" polynomial encoding tallies of maximal clique sizes "MaximalCliques" maximal cliques "MaximumCliqueCount" number of maximum cliques "MaximumCliques" maximum cliques "MinimumCoveringsByMaximalCliques" smallest coverings by maximal cliques "MinimumCoveringsByMaximalCliquesCount" number of smallest coverings by maximal cliques "SimplexGraph" simplex graph - Cover‐related properties include:
-
"CliqueCoveringNumber" minimum number of maximum cliques needed to cover the vertex set "EdgeCoverCount" number of edge covers "EdgeCoverNumber" size of the minimum edge cover "EdgeCoverPolynomial" edge cover polynomial "EdgeCovers" edge covers "MinimalEdgeCoverCount" number of minimal edge covers "MinimalEdgeCoverPolynomial" polynomial encoding tallies of minimal edge cover sizes "MinimalEdgeCovers" minimal edge covers "MinimalVertexCoverCount" number of minimal vertex covers "MinimalVertexCoverPolynomial" polynomial encoding tallies of minimal vertex cover sizes "MinimalVertexCovers" minimal vertex covers "MinimumCliqueCoveringCount" number of minimum clique coverings "MinimumCliqueCoverings" minimum clique coverings "MinimumEdgeCoverCount" number of minimum edge covers (matchings) "MinimumEdgeCovers" minimum edge covers (matchings) "MinimumPathCoveringCount" number of minimum path coverings "MinimumPathCoverings" minimum path coverings "MinimumVertexCoverCount" number of minimum vertex covers "MinimumVertexCovers" minimum vertex covers "PathCoveringNumber" path covering number "VertexCoverCount" number of vertex covers "VertexCoverNumber" size of a minimum vertex cover "VertexCoverPolynomial" vertex cover polynomial - Independent set‐related properties include:
-
"BipartiteDimension" bipartite dimension "EdgeIndependenceNumber" tallies of independent edge set sizes "FractionalIndependenceNumber" fractional independence number "IndependenceNumber" size of the largest independent vertex set "IndependencePolynomial" independence polynomial "IndependenceRatio" independence ratio "IndependentEdgeSetCount" number of independent edge sets "IndependentEdgeSets" independent edge sets "IndependentVertexSetCount" number of independent vertex sets "IndependentVertexSets" independent vertex sets "IntersectionNumber" intersection number "LowerIndependenceNumber" size of the smallest maximal independent vertex set "LowerMatchingNumber" size of the smallest maximal independent edge set "MatchingGeneratingPolynomial" matching‐generating polynomial "MatchingNumber" degree of the matching‐generating polynomial "MatchingPolynomial" matching‐generating polynomial "MaximalIndependencePolynomial" polynomial encoding the numbers of maximal independent vertex sets by size "MaximalIndependentEdgeSetCount" number of maximal independent edge sets (matchings) "MaximalIndependentEdgeSets" maximal independent edge sets (matchings) "MaximalIndependentVertexSetCount" number of maximal independent vertex sets "MaximalIndependentVertexSets" maximal independent vertex sets "MaximalMatchingGeneratingPolynomial" polynomial encoding the numbers of maximal independent edge sets by size "MaximumIndependentEdgeSetCount" number of maximum independent edge sets (matchings) "MaximumIndependentEdgeSets" maximum independent edge sets (matchings) "MaximumIndependentVertexSetCount" number of maximum independent vertex sets "MaximumIndependentVertexSets" maximum independent vertex sets - Irredundant set‐related properties include:
-
"IrredundanceNumber" (lower) irredundance number "IrredundancePolynomial" irredundance polynomial "IrredundantSetCount" number of irredundant sets "IrredundantSets" irredundant sets "MaximalIrredundancePolynomial" polynomial encoding tallies of maximal irredundant set sizes "MaximalIrredundantSetCount" number of maximal irredundant sets "MaximalIrredundantSets" maximal irredundant sets "MaximumIrredundantSetCount" number of maximum irredundant sets "MaximumIrredundantSets" maximum irredundant sets "UpperIrredundanceNumber" upper irredundance number - Dominating set‐related properties include:
-
"ConnectedDominatingSetCount" connected dominating set count "ConnectedDominatingSets" connected dominating sets "ConnectedDominationNumber" size of smallest possible connected dominating set "ConnectedDominationPolynomial" polynomial encoding tallies of connected dominating set sizes "DomaticNumber" maximum number of disjoint dominating sets in a domatic partition of a graph "DominatingSetCount" number of dominating sets "DominatingSets" dominating sets "DominationNumber" size of smallest possible dominating set "DominationPolynomial" polynomial encoding tallies of dominating set sizes "MinimalConnectedDominatingSetCount" number of minimal connected dominating sets "MinimalConnectedDominatingSets" minimal connected dominating sets "MinimalConnectedDominationPolynomial" polynomial encoding tallies of minimal connected dominating set sizes "MinimalDominatingSetCount" number of minimal dominating sets "MinimalDominatingSets" minimal dominating sets "MinimalDominationPolynomial" polynomial encoding tallies of minimal dominating set sizes "MinimalTotalDominatingSetCount" number of minimal total dominating sets "MinimalTotalDominatingSets" minimal total dominating sets "MinimalTotalDominationPolynomial" polynomial encoding tallies of minimal total dominating set sizes "MinimumConnectedDominatingSetCount" minimum connected dominating set count "MinimumConnectedDominatingSets" minimum connected dominating sets "MinimumDominatingSetCount" number of minimum dominating sets "MinimumDominatingSets" minimum dominating sets "MinimumTotalDominatingSetCount" number of minimum total dominating sets "MinimumTotalDominatingSets" minimum total dominating sets "TotalDominatingSetCount" number of total dominating sets "TotalDominatingSets" total dominating sets "TotalDominationNumber" size of smallest possible total dominating set "TotalDominationPolynomial" polynomial encoding the tallies of total dominating set sizes "UpperDominationNumber" size of the largest maximal dominating set - Symmetry‐related properties include:
-
"ArcTransitivity" maximal order s of an s‐arc-transitive graph "AutomorphismCount" order of the vertex automorphism group "AutomorphismGroup" graph automorphism permutation group "CanonicalPolyhedronDistinctEdgeLengthCount" number of distinct edge lengths in the corresponding canonical polyhedron "CayleyGraphGeneratingGroupNames" names of groups that generate the graph as a Cayley graph "CayleyGraphGeneratingGroups" groups that generate the graph as a Cayley graph "DistinguishingNumber" distinguishing number "FixingNumber" fixing number "MinimumDistinguishingLabelingCount" number of minimum distinguishing labelings "MinimumDistinguishingLabelings" minimum distinguishing labelings "PlanarEmbeddingCount" number of planar embeddings "SymmetricallyDistinctFaceCount" number of symmetrically distinct faces "SymmetricallyDistinctFaces" list of symmetrically distinct face representatives "SymmetricallyDistinctVertexPairCount" number of symmetrically distinct vertex pairs "SymmetricallyDistinctVertexPairSignature" signature of symmetrically distinct vertex pairs "SymmetricallyDistinctVertices" list of symmetrically distinct vertex representatives "SymmetricallyDistinctVertexCount" number of symmetrically distinct vertices "SymmetricallyEquivalentFaces" lists of symmetrically equivalent faces "SymmetricallyEquivalentVertices" lists of symmetrically equivalent vertices - Information‐related properties include:
-
"Bandwidth" graph bandwidth "BroadcastTime" graph broadcast time "BroadcastTimes" list of vertex broadcast times "BurningNumber" burning number "CheegerConstant" Cheeger constant "Conductance" graph conductance "CoolingNumber" cooling number "Gonality" gonality "Likelihood" probability for graph to be generated by random number and corresponding vertex -subset picking
"LovaszNumber" Lovász number (estimate of Shannon capacity) "Pathwidth" graph pagewidth "PebblingNumber" pebbling number "ScrambleNumber" scramble number "ShannonCapacity" effective alphabet size in a graph‐represented communication model "TreeDepth" tree depth "Treewidth" graph treewidth - Path‐ and cycle‐related properties include:
-
"ChordlessCycleCount" number of chordless cycles of length at least 4 "ChordlessCyclePolynomial" polynomial encoding tallies of chordless cycle by length "ChordlessCycles" cycles of length at least 4 with no chords "ComplementChordlessCycleCount" number of chordless cycles in the graph complement "ComplementChordlessCyclePolynomial" polynomial encoding tallies of chordless cycles of the graph complement by length "ComplementChordlessCycles" chordless cycles of length at least 4 in the graph "ComplementOddChordlessCycleCount" number of odd chordless cycles in the graph complement "ComplementOddChordlessCyclePolynomial" polynomial encoiding tallies of odd chordless cycles of the graph complement by length "ComplementOddChordlessCycles" odd chordless cycles of length at least 4 in the graph complement "CubeGraph" graph cube "CycleCount" number of distinct cycles "CyclePolynomial" cycle polynomial "Cycles" lists of cycles "EulerianCycleCount" number of distinct Eulerian cycles "EulerianCycles" lists of Eulerian cycles "FaceSignature" tallies of face lengths "Girth" length of the shortest cycle "HamiltonDecompositionCount" number of Hamilton decompositions "HamiltonDecompositions" partitions of edge set into Hamiltonian cycles "HamiltonianCycleCount" number of distinct Hamiltonian cycles "HamiltonianCycles" lists of Hamiltonian cycles "HamiltonianNumber" length of a shortest Hamiltonian walk "HamiltonianPathCount" number of distinct Hamiltonian paths "HamiltonianPaths" lists of Hamiltonian paths "HamiltonianWalkCount" number of distinct Hamiltonian walks "HamiltonianWalks" lists of Hamiltonian walks "HexagonCount" number of 6-cycles "KCyclicIndices" indices that label the graph as the
th
-cyclic graph
"LCFSignature" tally of the orders of all possible LCF signatures "LongestCycleCount" number of longest cycles "LongestCycles" longest cycles "LongestPathCount" number of longest paths "LongestPathLength" length of longest path "LongestPaths" longest paths "MinimumPathCoveringCount" number of minimum path coverings "MinimumPathCoverings" minimum path coverings "OddChordlessCycleCount" number of odd chordless cycles of length greater than 3 "OddChordlessCyclePolynomial" polynomial encoding tallies of numbers of odd chordless cycles by length "OddChordlessCycles" chordless cycles of odd length greater than 3 "PathCount" number of distinct paths "PathCoveringNumber" path covering number "PathPolynomial" path polynomial "PathPolynomialMatrix" matrix function of path polynomials "Paths" lists of paths "PentagonCount" number of 5-cycles "Radius" radius of the graph "SquareCount" number of 4-cycles "SquareGraph" square graph "TriangleCount" number of 3-cycles - Graph centralities include:
-
"BetweennessCentralities" betweenness centralities "ClosenessCentralities" closeness centralities "DegreeCentralities" vertex degrees "EccentricityCentralities" reciprocal of vertex eccentricities "EdgeBetweennessCentralities" edge betweenness centralities "EigenvectorCentralities" eigenvector centralities "HITSCentralities" hub centralities "KatzCentralities" Katz centralities "LinkRankCentralities" link rank centralities "PageRankCentralities" page rank centralities "RadialityCentralities" radiality centralities "StatusCentralities" status centralities - Graph clustering coefficients include:
-
"GlobalClusteringCoefficient" global clustering coefficient "LocalClusteringCoefficients" local clustering coefficients "MeanClusteringCoefficient" mean clustering coefficient - Naming‐related properties include:
-
"AlternateNames" alternate English names "AlternateStandardNames" alternate standard Wolfram Language names "Entity" graph entity "Name" English name "Names" English name and alternate names "StandardName" standard Wolfram Language name "StandardNames" standard and alternate Wolfram Language names - Notation‐related properties include:
-
"HouseOfGraphID" House of Graphs identifier "LCFNotations" graph notations for embeddings based on Hamiltonian cycles "Notation" primary notation used for graph "NotationRules" rules for notations specifying the graph "WikidataID" Wikidata identifier - GraphData["class"] gives a list of named graphs in the specified class. GraphData[name,"class"] gives True or False, depending on whether the graph corresponding to name is in the specified class.
- GraphData[name,"Classes"] gives a list of the classes in which the graph corresponding to name appears.
- Basic classes of graphs include:
-
"Bipartite" bipartite (two components connected by every edge) "Nonplanar" nonplanar (requires crossings) "Nonsimple" nonsimple graph "Planar" planar (no crossings) "Simple" simple graph (unlabeled, undirected) "Tree" tree (no cycles) - Classes based on crossings include:
-
"Apex" apex graph "CriticalNonplanar" nonplanar and removal of any vertex gives a planar graph "Doublecross" crossing number 2 "DoubleToroidal" genus 2 "IntrinsicallyLinked" intrinically linked "LinklesslyEmbeddable" linklessly embeddable "Map" map graph "Nonplanar" crossing number ≥ 1 "Planar" crossing number 0 "Pretzel" genus 3 "Singlecross" crossing number 1 "Toroidal" minimally embeddable on a torus - Classes based on vertex degrees include:
-
"Cubic" each vertex is of degree 3 "HighlyIrregular" neighbors of each vertex have distinct vertex degrees "Multigraphic" one or more other graphs share the degree sequence "Octic" each vertex is of degree 8 "Quartic" each vertex is of degree 4 "QuasiRegular" each vertex is of the same degree except a single one with degree one larger than the others "Quintic" each vertex is of degree 5 "Regular" each vertex is of the same degree "Septic" each vertex is of degree 7 "Sextic" each vertex is of degree 6 "Switchable" can be reduced to another graph with the same degree sequence by edge switching "TwoRegular" each vertex is of degree 2 "Unigraphic" no other graph shares the degree sequence "Unswitchable" not switchable - Classes based on traversals include:
-
"Acyclic" free of cycles "AlmostHamiltonian" -node graph with Hamiltonian number
"AlmostHypohamiltonian" almost Hamiltonian "Antipodal" each vertex has exactly one maximum-distance vertex "Bridged" contains at least one bridge "Bridgeless" free of bridges "Chordal" free of chordless cycles of length at least 4 "Chordless" free of chords "Cyclic" contains at least one cycle "Eulerian" has a closed cycle containing every edge once "Geodetic" has a unique shortest path between any two vertices "HamiltonConnected" every pair of vertices bounds a Hamiltonian path "HamiltonDecomposable" has a partition of its edge set into Hamiltonian cycles "Hamiltonian" has a closed cycle containing every vertex once "HamiltonLaceable" Hamilton‐connected with bipartitioned endpoints "HStarConnected" either Hamilton‐connected or Hamilton‐laceable "Hypohamiltonian" one‐vertex‐removed graphs are Hamiltonian "Hypotraceable" one‐vertex‐removed graphs are traceable "KempeCounterexample" counterexample to Kempe's 4‐coloring algorithm "MaximallyNonhamiltonian" maximally nonhamiltonian "Median" median graph "Meyniel" every odd cycle of length ≥5 has at least 2 chords "Noneulerian" not Eulerian "Nonhamiltonian" not Hamiltonian "Pancyclic" contains cycles of all lengths from 3 to vertex count "SquareFree" free of 4‐cycles "Traceable" contains a Hamiltonian path "TriangleFree" free of 3‐cycles "Unicyclic" possesses a unique cycle "UniquelyHamiltonian" possessing a unique Hamiltonian cycle "UniquelyPancyclic" uniquely pancyclic "Untraceable" not traceable - Classes based on chess boards include:
-
"Antelope" moves of an antelope generalized chess piece "Bishop" moves of two (white and black) chess bishops "BlackBishop" moves of a chess black bishop "Fiveleaper" moves of a fiveleaper generalized chess piece "Camel" moves of a (1,3)-leaper graph "Giraffe" moves of a (1,4)-leaper graph "King" moves of a chess king "Knight" moves of a chess knight "Queen" moves of a chess queen "Rook" moves of a chess rook "RookComplement" graph complement of a rook graph "TriangularHoneycombAcuteKnight" moves of an acute knight on a triangular honeycomb chess board "TriangularHoneycombBishop" moves of a bishop on a triangular honeycomb chess board "TriangularHoneycombKing" moves of a king on a triangular honeycomb chess board "TriangularHoneycombObtuseKnight" moves of an obtuse knight on a triangular honeycomb chess board "TriangularHoneycombQueen" moves of a queen on a triangular honeycomb chess board "TriangularHoneycombRook" moves of a rook on a triangular honeycomb chess board "WhiteBishop" moves of a chess white bishop "Zebra" moves of a (2,3)-leaper graph - Classes based on symmetry and regularity include:
-
"ArcTransitive" ordered pairs of adjacent vertices have identical environments "Asymmetric" not symmetric "Chang" strongly regular on 28 vertices "ConformallyRigid" conformally rigid "DistanceRegular" all vertices have identical distance sets "DistanceTransitive" all pairs of vertices have identical distance environments "EdgeTransitive" all edges have identical environments "Geometric" every edge of a distance-regular graph lies in a unique Delsarte clique "Identity" automorphism group is of order unity "LocallyPetersen" locally Petersen "Nongeometric" nongeometric "Paulus" strongly regular on 25 or 26 vertices "Semisymmetric" regular and edge transitive but not vertex transitive "StronglyRegular" strongly regular "Symmetric" both edge transitive and vertex transitive "Taylor" distance regular with intersection array of form "UniquelyEmbeddable" uniquely embeddable "VertexTransitive" all vertices have identical environments "WeaklyRegular" regular, but not strongly regular "ZeroSymmetric" vertex‐transitive cubic with edges partitioned into three orbits "ZeroTwo" every two vertices have either 0 or 2 common neighbors - Spectral classes include:
-
"Integral" spectrum consists of integers "Line" line graph "Maverick" maverick graph - Classes based on forbidden graphs include:
-
"Beineke" Beineke graph (line graph forbidden induced subgraph) "Kuratowski" Kuratowski graph (planar graph forbidden induced subgraph) "Metelsky" Metelsky graph (ine graph forbidden if induced subgraph)
"Pathwidth1ForbiddenMinor" pathwidth 1 forbidden minor "Pathwidth2ForbiddenMinor" pathwidth 2 forbidden minor "PetersenFamily" linklessly embeddable forbidden minor "ProjectivePlanarForbiddenMinor" projective planar forbidden minor "ProjectivePlanarForbiddenTopologicalMinor" projective planar forbidden topological minor "ToroidalForbiddenMinor" toroidal graph forbidden minor "UnitDistanceForbiddenSubgraph" minimal unit-distance forbidden subgraph - Special classes include:
-
"DistanceHereditary distance-hereditary graph "AlmostControllable" almost-controllable graph "Bicolorable" two or fewer vertex colors needed "Bicubic" bipartite and cubic "Biplanar" biplanar "Block" block graph "BracedPolygon" braced regular polygon graph "Cage" smallest graph of a given girth "Cayley" Cayley graph "ChromaticallyUnique" no other graph shares the chromatic polynomial "ClawFree" free of the claw graph "Conference" conference graph "Configuration" graph represents a point-line configuration "Controllable" controllable graph "Flexible" infinitesimally flexible graph "Fullerene" planar cubic with all bounded faces pentagons or hexagons "Fusene" planar 2‐connected with all bounded faces hexagons "Graceful" graceful graph "Imperfect" imperfect (i.e. not perfect) graph "Incidence" incidence graph of a configuration "Laman" minimal rigid (Laman) graph "LCF" describable in LCF notation (regular Hamiltonian) "Local" graph is locally a particular graph for all vertices "Matchstick" embeddable with a planar drawing having unit edge lengths "Moore" graphs with the Moore property "Nonempty" nonempty graph "NoPerfectMatching" has no perfect matching "Nuciferous" nuciferous graph "Nut" adjacency matrix has rank 1 and contains no 0 element "Ore" Ore graph "Outerplanar" outerplanar graph "Perfect" perfect graph "PerfectMatching" has a matching with vertices
"Polyhex" polyhex graph "Polyiamond" polyiamond graph "Polyomino" polyomino graph "ProjectivePlanar" graph can be drawn on the real projective plane "Ptolemaic" Ptolemaic graph "QuadraticallyEmbeddable" quadratically embeddable graph "Rigid" infinitesimally rigid graph "SelfComplementary" isomorphic to its complement "SelfDual" isomorphic to its dual "Split" split graph "StronglyPerfect" every induced subgraph has an independent set meeting all maximal cliques of
"UniquelyColorable" vertex-colorable in a single way modulo graph symmetry and permutation of colors "UnitDistance" embeddable with edges of unit length "WeaklyPerfect" clique number equals chromatic number "WellCovered" every minimal vertex cover has the same size - Classes associated with polyhedra include:
-
"Antiprism" skeleton of an antiprism "Archimedean" skeleton of one of the 13 Archimedean solids "ArchimedeanDual" skeleton of one of the 13 Archimedean duals "Dipyramid" skeleton of a dipyramid "JohnsonSkeleton" skeleton of one of the 92 Johnson solids "Platonic" skeleton of one of the five Platonic solids "Polyhedral" skeleton of a polyhedron "Prism" skeleton of a prism "RegularPolychoron" skeleton of one of the six regular four‐dimensional solids "Trapezohedron" skeleton of a trapezohedron "UniformSkeleton" skeleton of a uniform polyhedron "Wheel" skeleton of a pyramid - Snark-related classes include:
-
"Flower" flower graph (snark for n5, 7, …) "Goldberg" Goldberg graph (snark for n5, 7, …) "Snark" snark (cyclically 4-edge connected cubic graph with edge chromatic number 4 and girth at least 5) "WeakSnark" weak snark (cyclically 4-edge connected cubic graph with edge chromatic number 4 and girth at least 4) - Special classes of trees and their generalization include:
-
"Cactus" connected graph in which any two cycles have no edge in common "Caterpillar" vertices are on a central stalk or only one edge away from a stalk "Centipede" vertices and edges correspond to the configuration of a comb "Forest" a collection of trees (same as "Acyclic") "FullyReconstructibleC1" determined from its 1‐dimensional measurement variety "FullyReconstructibleC2" determined from its 2‐dimensional measurement variety "FullyReconstructibleC3" determined from its 3‐dimensional measurement variety "Halin" Halin graph "KTree" -tree
"Lobster" removal of leaves gives a caterpillar "Pseudoforest" contains at most one cycle per connected component "Pseudotree" a connected pseudoforest "SeriesReduced" series-reduced tree (no vertices of degree 2) "Spider" one vertex of degree at most 3 and all others ≤2 "Tripod" a tree having exactly three tree leaves - Classes of graphs indexed by one or more integers include:
-
"Accordion" accordion graph "Alkane" n alkane graph "Apollonian" connectivity graph of a 2D Apollonian gasket "BipartiteKneser" vertices represent k subsets and n‐k subsets of "Book" graph Cartesian product of a star and a two‐path graph "Bouwer" regular graphs including members that are symmetric but not arc transitive "Bruhat" graph whose vertices are permutations on n symbols with edges for permutations differing by an adjacent transposition "Caveman" caveman graph "Circulant" n vertices each with identical relative adjacencies "Complete" all pairs of vertices are connected "CompleteBipartite" all pairs connected across two disjoint sets of vertices "CompleteKPartite" all pairs connected across disjoint sets of vertices
"CompleteTripartite" all neighboring pairs connected across three disjoint sets of vertices "Cone" graph join of a cycle graph and empty graph "Crown" complete bipartite with horizontal edges removed
"Cycle" a single cycle through n vertices "CycleComplement" complement graph of the cycle graph "Cyclotomic" graph with vertices adjacent if their difference is a cube in "DiagonalIntersection" graph with vertices formed from the vertices of a regular n-gon and the intersection of its diagonals "Dipyramid" skeleton graph of an n-dipyramid "Doob" Cartesian product of Shrikhande graphs and a Hamming graph "DorogovtsevGoltsevMendes" Dorogovtsev-Goltsev-Mendes graph "DoubleCone" double cone graph with n-gonal bases "Egawa" Egawa graph "Empty" n vertices with no edges "Fan" graph join of an empty graph with a path graph "FibonacciCube" a Fibonacci cube graph "Flower" flower graph (snark for n5, 7, …) "FoldedCube" folded n‐hypercube graph "Gear" a wheel with vertices added between the vertices of the outer cycle "GeneralizedPolygon" an incidence plane based on a symmetric binary relation "GoethalsSeidelBlockDesign" Goethals–Seidel block design graph "Goldberg" Goldberg graph (snark for n5, 7, …) "Grassmann" Grassmann graph "Grid" an array of points with grid connectivity "Haar" Haar (regular bipartite) graph of index n "Hadamard" graph corresponding to a matrix satisfying
"HalvedCube" halved n‐hypercube graph "Hamming" direct product of m complete graphs of size n "Hanoi" a Hanoi graph "Harary" a Harary graph "Helm" a wheel with a pendant edge adjoined at each cycle vertex "HexagonalGrid" hexagonal grid graph "HoneycombToroidal" honeycomb toroidal graph "Hypercube" an n‐dimensional hypercube "IGraph" generalization of a generalized Petersen graph "Jahangir" Jahangir graph "Johnson" graph describing adjacencies in the m‐subsets of an n‐set "JohnsonSkeleton" skeleton graph of the n Johnson solid
"KayakPaddle" kayak paddle graph "Keller" Keller graph "KleinBottleTriangulation" a regular triangulation of a Klein bottle "Kneser" vertices represent k‐subsets of {1,…,n} "Ladder" a 2n‐vertex ladder graph "LadderRung" graph union of n two‐paths "LindgrenSousselier" Lindgren-Sousselier graphs "LucasCube" Lucas cube graph "Mathon" Mathon graph "MengerSponge" connectivity graph of a Menger sponge "MiddleLayer" middle layer graph "MoebiusLadder" an n‐sided prism graph with a half‐twist "Mycielski" a triangle‐free graph with chromatic number n "Odd" an odd graph "Paley" graph with vertices adjacent if their difference is a square in "Pan" an n‐cycle connected to a singleton graph by a bridge "Pasechnik" Pasechnik graph "Path" an n‐vertex tree with no branches "PathComplement" complement graph of the path graph "Pell" Pell graph "PermutationStar" a "star graph" on permutations of {1,…,n} with edges at swaps "PlummerToft" Plummer-Toft graphs "SierpinskiCarpet" connectivity graph of the Sierpiński carpet "SierpinskiSieve" connectivity graph of the Sierpiński sieve "SierpinskiTetrahedron" connectivity graph of the Sierpiński tetrahedron (tetrix) "Spoke" spoke graph with arms and
vertices per arm
"StackedBook" graph Cartesian product of a star and a path graph "StackedPrism" a stacked prism graph "Star" a center vertex connected to n‐1 vertices "Sun" a complete graph with erected triangles on outer edges "Sunlet" a cycle with pendant edges "Tetrahedral" an ‐Johnson graph
"TorusGrid" grid graph on a torus "TorusTriangulation" a regular triangulation of a torus "Transposition" a transposition graph "Triangular" an ‐Johnson graph
"TriangularGrid" a triangular grid graph "TriangularSnake" triangular snake graph "Turan" a Turán graph on n vertices that is (k+1)‐clique free "Wheel" a cycle with all vertices connected to a center "WheelComplement" complement of a wheel graph "Windmill" m copies of the complete graph with a vertex in common
"Wreath" n collections of k nodes arranged around a circle such that all nodes in adjacent collections are connected - GraphData[name,"property","type"] gives a set of specific graphs, images, or embeddings, where in 2D "type" may include "3D", "All", "Circulant", "Circular", "Degenerate", "Gear", "GeneralizedPetersen", "Grid", "Halin", "IGraph", "IntegerCoordinates", "Integral", "LCF", "Linear", "Matchstick", "MinimalCrossing", "MinimalIntegral", "MinimalLocalCrossing", "MinimalPlanarIntegral", "MinimalRectilinearCrossing", "MinimalRectilinearLocalCrossing", "Perspective", "Planar", "Polyiamond", "Polyomino", "Primary", "Torus", "TriangularGrid", "UnitDistance", and "XYZ"; and in 3D "type" may include "Grid", "IntegerCoordinates", "Integral", "Polyhedron", "Primary", "TetrahedralGrid", "UnitDistance", and "XYZ".
- Type properties related to graph display include:
-
"Embeddings" embeddings of a given type "EmbeddingClasses" list of embedding classifications "Graph" graph of a given type "Graphics" graphics "Graphics3D" 3D graphics "Image" images of a given type "MeshRegion" mesh region - GraphData[name,"property","outputtype"] gives graph properties in the format specified by "outputtype", which, depending on "property", may be "All", "Count", "Directed", "Edge", "Entity", "Graph", "Graphics", "Group", "Image", "Labeled", "List", "Name", "Pair", "Polyhedron", "Rule", or "Undirected".
- Output type properties related to graph output include:
-
"BipartiteDoubleGraph" bipartite double graph "CanonicalGraph" canonical version of graph that is isomorphic to the original "CayleyGraphGeneratingGroups" groups generating corresponding to graph as a Cayley graph as groups, entities, or entity names "CochromaticGraphs" cochromatic graphs as graphs, entities, entity names, 3D graphs, graphics, or images "CodegreeSequenceGraphs" codegree sequence graphs as graphs, entities, entity names, 3D graphs, graphics, or images "ComplementGraph" complement graph as a graph, entity, entity name, graphics, or image "ConnectedComponents" connected components as graphs, entities, entity names, 3D graphs, graphics, or images "CoresistanceGraphs" coresistance graphs as graphs, entities, entity names, 3D graphs, graphics, or images "CospectralGraphs" cospectral graphs as graphs, entities, entity names, 3D graphs, graphics, or images "CubeGraph" cube graph as a graph, entity, entity name, graphics, or image "DualGraph" dual graph as a graph, entity, entity name, graphics, or image "LeviGraph" Levi graph as a graph, entity, entity name, graphics, or image "LineGraph" line graph as a graph, entity, entity name, graphics, or image "LocalGraph" local graph as a graph, entity, entity name, graphics, or image "OrdinaryLineGraph" ordinary line graph "PolyhedralEmbeddings" polyhedra having given graph as a skeleton as polyhedra, entities, or entity names "RootGraph" root graph as a graph, entity, entity name, graphics, or image "SimplexGraph" simplex graph as a graph, entity, entity name, graphics, or image "SquareGraph" square graph as a graph, entity, entity name, graphics, or image - GraphData[name,"property","ann"] or GraphData["property","ann"] gives various annotations associated with a property. Typical annotations include:
-
"Description" short textual description of the property "Information" hyperlink to additional information "LongDescription" longer textual description of the property "Note" additional information about the property "Value" the value of the property - Using GraphData may require internet connectivity.
Examples
open allclose allBasic Examples (4)Summary of the most common use cases
Return a list of standard names for all simple graphs on 5 vertices:

https://wolfram.com/xid/0e7p5nb2-30qni8

Give the corresponding Graph objects:

https://wolfram.com/xid/0e7p5nb2-kmt7rh

Do the same without explicitly specifying the default "Graph" property:

https://wolfram.com/xid/0e7p5nb2-hvjyv0


https://wolfram.com/xid/0e7p5nb2-fmz5ge

Show all available 2D embeddings of the graph:

https://wolfram.com/xid/0e7p5nb2-za3wzb

Show the spectrum of the icosahedral graph:

https://wolfram.com/xid/0e7p5nb2-md5inq

Generate a list of named snark graphs:

https://wolfram.com/xid/0e7p5nb2-fswpwi


https://wolfram.com/xid/0e7p5nb2-jyom9b

Scope (741)Survey of the scope of standard use cases
Names and Classes (7)
Obtain a list of all standard implemented graphs:

https://wolfram.com/xid/0e7p5nb2-yfb41f


https://wolfram.com/xid/0e7p5nb2-p6u93n

Obtain a list of all implemented graphs:

https://wolfram.com/xid/0e7p5nb2-jp7blu


https://wolfram.com/xid/0e7p5nb2-eqig3n

Find the English name of a graph:

https://wolfram.com/xid/0e7p5nb2-dxyruk

A list of alternate names can also be found:

https://wolfram.com/xid/0e7p5nb2-typed

Additional names acceptable as input can be found:

https://wolfram.com/xid/0e7p5nb2-p1hvl4


https://wolfram.com/xid/0e7p5nb2-crdphk

Find the list of graph classes:

https://wolfram.com/xid/0e7p5nb2-rf8cr

Find the list of named graphs belonging to a class:

https://wolfram.com/xid/0e7p5nb2-nfye2n


https://wolfram.com/xid/0e7p5nb2-n286w

Test whether a graph belongs to a class:

https://wolfram.com/xid/0e7p5nb2-j4935

Properties and Annotations (2)
Get a list of properties for a particular graph:

https://wolfram.com/xid/0e7p5nb2-c9swca

Get a short textual description of a property:

https://wolfram.com/xid/0e7p5nb2-4v7haq

Get a longer textual description:

https://wolfram.com/xid/0e7p5nb2-cwfej

Property Values (4)
The values of properties may take a variety of forms as Wolfram Language expressions:

https://wolfram.com/xid/0e7p5nb2-i086aw


https://wolfram.com/xid/0e7p5nb2-1ju5lf


https://wolfram.com/xid/0e7p5nb2-6fjaqu


https://wolfram.com/xid/0e7p5nb2-kc6f2g


https://wolfram.com/xid/0e7p5nb2-jknk8w


https://wolfram.com/xid/0e7p5nb2-g61b66


https://wolfram.com/xid/0e7p5nb2-g46w3f

A property that is not available for a graph has the value Missing["NotAvailable"]:

https://wolfram.com/xid/0e7p5nb2-c8hvnz

Some graph properties may be Missing but still include partial information:

https://wolfram.com/xid/0e7p5nb2-iygno7


https://wolfram.com/xid/0e7p5nb2-nmht48

A property whose value is too large to include has the value Missing["TooLarge"]:

https://wolfram.com/xid/0e7p5nb2-kfzued


https://wolfram.com/xid/0e7p5nb2-o9roqr

Detailed Properties (728)
Basic Graph Properties (9)
Give the adjacency matrix, returned as a SparseArray object:

https://wolfram.com/xid/0e7p5nb2-gegvxc

Convert to an explicit matrix:

https://wolfram.com/xid/0e7p5nb2-znkdm9


https://wolfram.com/xid/0e7p5nb2-835lrf

Plot the matrix using ArrayPlot:

https://wolfram.com/xid/0e7p5nb2-qhva5x

Verify that the positions of 1s in the adjacency matrix correspond to graph edges:

https://wolfram.com/xid/0e7p5nb2-s6xsvl


https://wolfram.com/xid/0e7p5nb2-vjw84m


https://wolfram.com/xid/0e7p5nb2-g6behz

List the number of distinct adjacency matrices possible for the cubical graph:

https://wolfram.com/xid/0e7p5nb2-25hiiq


https://wolfram.com/xid/0e7p5nb2-wu98c0

Return the number of edges of the octahedral graph:

https://wolfram.com/xid/0e7p5nb2-uac5bl

Compare with taking the length of the edge list:

https://wolfram.com/xid/0e7p5nb2-ktm3pc

Return the edges of the octahedral graph:

https://wolfram.com/xid/0e7p5nb2-it4xkn


https://wolfram.com/xid/0e7p5nb2-3tefd5

Give the face count of the octahedral graph:

https://wolfram.com/xid/0e7p5nb2-q00ni5

Give the faces of the octahedral graph:

https://wolfram.com/xid/0e7p5nb2-c4p0fp


https://wolfram.com/xid/0e7p5nb2-q5pxv9

Give the incidence matrix of the octahedral graph:

https://wolfram.com/xid/0e7p5nb2-srhu8z


https://wolfram.com/xid/0e7p5nb2-0pywg4


https://wolfram.com/xid/0e7p5nb2-oz05v6

Give the number of vertices of the octahedral graph:

https://wolfram.com/xid/0e7p5nb2-g6q7q7

Return the vertices of the octahedral graph:

https://wolfram.com/xid/0e7p5nb2-7cuiov


https://wolfram.com/xid/0e7p5nb2-2pvcwm

Properties Related to Graph Connectivity (30)
Give the block count of the butterfly graph:

https://wolfram.com/xid/0e7p5nb2-3i4xvs


https://wolfram.com/xid/0e7p5nb2-8ibd3a


https://wolfram.com/xid/0e7p5nb2-hooo3i

Give the blocks of the butterfly graph:

https://wolfram.com/xid/0e7p5nb2-1ige5x


https://wolfram.com/xid/0e7p5nb2-5xgcy8

Show the bridges of the 3-barbell graph:

https://wolfram.com/xid/0e7p5nb2-eqg7wu


https://wolfram.com/xid/0e7p5nb2-uasytr


https://wolfram.com/xid/0e7p5nb2-4gj1e8

List connected graphs on five vertices:

https://wolfram.com/xid/0e7p5nb2-2su929


https://wolfram.com/xid/0e7p5nb2-dwk2vn

Check if the graph is connected:

https://wolfram.com/xid/0e7p5nb2-ivbpf1


https://wolfram.com/xid/0e7p5nb2-ngd6bs

Check if the graph is connected:

https://wolfram.com/xid/0e7p5nb2-lp9n20


https://wolfram.com/xid/0e7p5nb2-r99437

Return the number of connected components in the graph:

https://wolfram.com/xid/0e7p5nb2-mnrng4

Do the same using the "Count" annotation:

https://wolfram.com/xid/0e7p5nb2-66ey8w

Return the connected components of the graph:

https://wolfram.com/xid/0e7p5nb2-gy6g5n

List the names of the connected components:

https://wolfram.com/xid/0e7p5nb2-tucjey

List the indices of connected components:

https://wolfram.com/xid/0e7p5nb2-84gx7k


https://wolfram.com/xid/0e7p5nb2-6rboce

Give the number of connected induced subgraphs of the diamond graph:

https://wolfram.com/xid/0e7p5nb2-2o0er9

Compare with the value obtained from the connected induced subgraph polynomial:

https://wolfram.com/xid/0e7p5nb2-yno4x6


https://wolfram.com/xid/0e7p5nb2-nbn01z

Display the diamond graph and compare the above counts with those computed from scratch:

https://wolfram.com/xid/0e7p5nb2-jknsg0


https://wolfram.com/xid/0e7p5nb2-mgco39


https://wolfram.com/xid/0e7p5nb2-dyfeuo

Give the connected induced subgraph polynomial of the diamond graph:

https://wolfram.com/xid/0e7p5nb2-byg9ka


https://wolfram.com/xid/0e7p5nb2-k9ywv0

Compare to the actual subgraphs:

https://wolfram.com/xid/0e7p5nb2-bb56hz


https://wolfram.com/xid/0e7p5nb2-cty4ph

Give the cyclic edge connectivity of the Petersen graph:

https://wolfram.com/xid/0e7p5nb2-0mi46w

Show the two cyclic components of a edge cut set of size 5:

https://wolfram.com/xid/0e7p5nb2-lvrse

https://wolfram.com/xid/0e7p5nb2-1tc3lb

https://wolfram.com/xid/0e7p5nb2-zib81m

https://wolfram.com/xid/0e7p5nb2-e4tlmb

List disconnected graphs on five vertices:

https://wolfram.com/xid/0e7p5nb2-yz1l5k

Check if the graph is disconnected:

https://wolfram.com/xid/0e7p5nb2-dnov37

Check if the graph is disconnected:

https://wolfram.com/xid/0e7p5nb2-drxfjo

Find the edge connectivity of a complete binary tree of order 4:

https://wolfram.com/xid/0e7p5nb2-fdngul


https://wolfram.com/xid/0e7p5nb2-bhwqi7

Return the number of edge cuts in the triangle graph:

https://wolfram.com/xid/0e7p5nb2-cupmlw

Do the same with the "Count" annotation:

https://wolfram.com/xid/0e7p5nb2-7xyoif

Compare with the length of edge cuts:

https://wolfram.com/xid/0e7p5nb2-gcpm29

Show the edge cuts in the triangle graph:

https://wolfram.com/xid/0e7p5nb2-yjnykb

Visualize how the cuts disconnect the graph:

https://wolfram.com/xid/0e7p5nb2-6s06uh

Give the incidence lines that generate the Pappus graph:

https://wolfram.com/xid/0e7p5nb2-7nfhy8


https://wolfram.com/xid/0e7p5nb2-6s3mhm

Show the Levi graph generated by these incidences:

https://wolfram.com/xid/0e7p5nb2-171m0d


https://wolfram.com/xid/0e7p5nb2-0twvkc

Give a realization of the Pappus configuration showing the incidences:

https://wolfram.com/xid/0e7p5nb2-6z7pct

Give the lambda components of the domino graph:

https://wolfram.com/xid/0e7p5nb2-5tuxpl


https://wolfram.com/xid/0e7p5nb2-o5w5bs

Give the Luccio–Sami components of the domino graph:

https://wolfram.com/xid/0e7p5nb2-esluwf


https://wolfram.com/xid/0e7p5nb2-lbro72

Return the number of minimal edge cuts in the triangle graph:

https://wolfram.com/xid/0e7p5nb2-jlcm80

Do the same with the "Count" annotation:

https://wolfram.com/xid/0e7p5nb2-9cfkqw

Compare with the length of edge cuts:

https://wolfram.com/xid/0e7p5nb2-wknsdb

Show the minimal edge cuts in the triangle graph:

https://wolfram.com/xid/0e7p5nb2-zob2kx

Visualize how the cuts disconnect the graph:

https://wolfram.com/xid/0e7p5nb2-lxo6x0

Return the number of minimal vertex cuts in the butterfly graph:

https://wolfram.com/xid/0e7p5nb2-vhorjg

Do the same with the "Count" annotation:

https://wolfram.com/xid/0e7p5nb2-bqk7uu

Compare with the length of edge cuts:

https://wolfram.com/xid/0e7p5nb2-edscll

Show the minimal edge cuts in the butterfly graph:

https://wolfram.com/xid/0e7p5nb2-irqkqk

Visualize how the cuts disconnect the graph:

https://wolfram.com/xid/0e7p5nb2-no6n5y

Return the number of minimum vertex cuts of the square graph with triangles erected on two opposite sides:

https://wolfram.com/xid/0e7p5nb2-1i17rc


https://wolfram.com/xid/0e7p5nb2-gxs4tm


https://wolfram.com/xid/0e7p5nb2-w4xefd


https://wolfram.com/xid/0e7p5nb2-gbsghh

Give the number of minimum cyclic edge cuts of the Petersen graph:

https://wolfram.com/xid/0e7p5nb2-hihyn4

Do the same as an annotation to "MinimumCyclicEdgeCuts":

https://wolfram.com/xid/0e7p5nb2-z3d524

Compare with the number of minimum cyclic edge cuts:

https://wolfram.com/xid/0e7p5nb2-qmehi5

Return the minimum cyclic edge cuts of the Petersen graph:

https://wolfram.com/xid/0e7p5nb2-hm5gml

Compare with the cyclic edge connectivity:

https://wolfram.com/xid/0e7p5nb2-qsska


https://wolfram.com/xid/0e7p5nb2-qn6z5

Visualize the cuts to reveal the resulting two cyclic components:

https://wolfram.com/xid/0e7p5nb2-o88bu0

https://wolfram.com/xid/0e7p5nb2-4w0pbr

Give the minimum vertex cuts of the square graph with triangles erected on two opposite sides:

https://wolfram.com/xid/0e7p5nb2-x3menr


https://wolfram.com/xid/0e7p5nb2-m4m5wj

Show the disconnected graphs resulting from these cuts:

https://wolfram.com/xid/0e7p5nb2-42isyq

Give spanning trees for the tetrahedral graph:

https://wolfram.com/xid/0e7p5nb2-byw63y

Give the strength of the butterfly graph:

https://wolfram.com/xid/0e7p5nb2-pvele2


https://wolfram.com/xid/0e7p5nb2-k7t8tn


https://wolfram.com/xid/0e7p5nb2-f2al33

https://wolfram.com/xid/0e7p5nb2-1bxzwp


https://wolfram.com/xid/0e7p5nb2-sspvwh

Give the toughness of the butterfly graph:

https://wolfram.com/xid/0e7p5nb2-xwz20p


https://wolfram.com/xid/0e7p5nb2-tvpzvj


https://wolfram.com/xid/0e7p5nb2-h7lsu7

https://wolfram.com/xid/0e7p5nb2-v3i8nj


https://wolfram.com/xid/0e7p5nb2-kpa8oa

Give the vertex connectivity of Tietze's graph:

https://wolfram.com/xid/0e7p5nb2-q7ak8x

Return the number of vertex cuts in the butterfly graph:

https://wolfram.com/xid/0e7p5nb2-4evspw

Do the same with the "Count" annotation:

https://wolfram.com/xid/0e7p5nb2-q9lm5m

Compare with the length of edge cuts:

https://wolfram.com/xid/0e7p5nb2-h5fbo2

Show the vertex cuts of the butterfly graph:

https://wolfram.com/xid/0e7p5nb2-vxwjpm

Visualize how the cuts disconnect the graph:

https://wolfram.com/xid/0e7p5nb2-qt8gc6

Properties Related to Graph Minors (2)
Show the number of graph minors the octahedral graph:

https://wolfram.com/xid/0e7p5nb2-gi6v4i

Give the Hadwiger number of a wheel complement graph:

https://wolfram.com/xid/0e7p5nb2-7en80z

Properties Related to Graph Display (12)
Show the default embedding of the octahedral graph:

https://wolfram.com/xid/0e7p5nb2-6kav16

Show classes of tabulated 2D embeddings of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-lunnq3


https://wolfram.com/xid/0e7p5nb2-bcj8qc

Show classes of known 3D embeddings of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-pkb1rd


https://wolfram.com/xid/0e7p5nb2-zyyoaa

List the known 2D embeddings of the octahedral graph:

https://wolfram.com/xid/0e7p5nb2-vticzz

List the known 3D embeddings of the octahedral graph:

https://wolfram.com/xid/0e7p5nb2-2rpweo

Show the default embedding of the octahedral graph:

https://wolfram.com/xid/0e7p5nb2-09icc3

Show the default 3D embedding of the octahedral graph:

https://wolfram.com/xid/0e7p5nb2-2ehrjj


https://wolfram.com/xid/0e7p5nb2-cz2dw3

Give all cataloged 3D embeddings of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-j390oy

Show a graphic of the octahedral graph:

https://wolfram.com/xid/0e7p5nb2-yn2s6w


https://wolfram.com/xid/0e7p5nb2-jw4pty

Give all cataloged embeddings of the octahedral graph as graphics:

https://wolfram.com/xid/0e7p5nb2-xmmmyf

Show a 3D graphic of the octahedral graph:

https://wolfram.com/xid/0e7p5nb2-cu8cg3


https://wolfram.com/xid/0e7p5nb2-8rpn0a

Give all cataloged embeddings of the cubical graph as 3D graphics:

https://wolfram.com/xid/0e7p5nb2-1e0p1t

Show an image of the default embedding of the octahedral graph:

https://wolfram.com/xid/0e7p5nb2-fve7u2

Show the three-dimensional embedding of the cubical graph as an image:

https://wolfram.com/xid/0e7p5nb2-8izhp

Show the Nauru graph as a mesh region:

https://wolfram.com/xid/0e7p5nb2-s4ol80


https://wolfram.com/xid/0e7p5nb2-p7z8xy


https://wolfram.com/xid/0e7p5nb2-ztxb16

Show all available embeddings as mesh regions:

https://wolfram.com/xid/0e7p5nb2-povjs9

Show a mesh region embedded in 3D:

https://wolfram.com/xid/0e7p5nb2-eqi98n


https://wolfram.com/xid/0e7p5nb2-v15xrg

Show the icosahedral graph as a polyhedron:

https://wolfram.com/xid/0e7p5nb2-tkpud6


https://wolfram.com/xid/0e7p5nb2-7g4389

Return the vertex coordinates for the default embedding of the octahedral graph:

https://wolfram.com/xid/0e7p5nb2-qiv8hq


https://wolfram.com/xid/0e7p5nb2-qt0tk7


https://wolfram.com/xid/0e7p5nb2-si884q

Show vertex coordinates for all cataloged embeddings:

https://wolfram.com/xid/0e7p5nb2-dmi65n

Annotatable Properties Related to Graph Output (20)
Return the bipartite double graph of the Clebsch graph:

https://wolfram.com/xid/0e7p5nb2-r53s9j

Give the standard name of the bipartite double graph:

https://wolfram.com/xid/0e7p5nb2-7qysm4

Return the cubical graph in canonical form:

https://wolfram.com/xid/0e7p5nb2-49mrx4


https://wolfram.com/xid/0e7p5nb2-bquaw4

The edge lists are not necessarily the same:

https://wolfram.com/xid/0e7p5nb2-tznjus

Verify the graphs are isomorphic:

https://wolfram.com/xid/0e7p5nb2-u3apnr

Return groups whose Cayley graphs generate the cubical graph using the default output type:

https://wolfram.com/xid/0e7p5nb2-p341ze

Return them explicitly as groups:

https://wolfram.com/xid/0e7p5nb2-qdhdvc

Return FiniteGroupData standard names whose Cayley graphs generate the cubical graph:

https://wolfram.com/xid/0e7p5nb2-n4jgq

Return FiniteGroupData entities whose Cayley graphs generate the cubical graph:

https://wolfram.com/xid/0e7p5nb2-iuqaae

Give cochromatic graphs of the claw graph:

https://wolfram.com/xid/0e7p5nb2-wc7s4y


https://wolfram.com/xid/0e7p5nb2-fuo1n4

Return the names of the cochromatic graphs:

https://wolfram.com/xid/0e7p5nb2-ufndpa

Verify these share the same chromatic polynomial:

https://wolfram.com/xid/0e7p5nb2-bjflls


https://wolfram.com/xid/0e7p5nb2-hr8bj8

Show graph names for graphs that are cochromatic with the 5-star graph:

https://wolfram.com/xid/0e7p5nb2-b1h0ki


https://wolfram.com/xid/0e7p5nb2-f4r1xm


https://wolfram.com/xid/0e7p5nb2-sww8ow

Give the names of graphs cochromatic with the bull graph:

https://wolfram.com/xid/0e7p5nb2-r2ccoj


https://wolfram.com/xid/0e7p5nb2-if5pdt


https://wolfram.com/xid/0e7p5nb2-tbvdpb


https://wolfram.com/xid/0e7p5nb2-isz4tm

Return the co-degree sequence graphs of the 5-path graph:

https://wolfram.com/xid/0e7p5nb2-bf9wgp

Since this graph shares a degree sequence, it is not unigraphic:

https://wolfram.com/xid/0e7p5nb2-nb956x

Return the graph complement of the icosahedral graph:

https://wolfram.com/xid/0e7p5nb2-kjliky

Do the same using the annotation "Graph":

https://wolfram.com/xid/0e7p5nb2-lx1ieo

Return as an Image:

https://wolfram.com/xid/0e7p5nb2-43mxam

Return as a Graphics object:

https://wolfram.com/xid/0e7p5nb2-8hvygi

Give the name of the complement graph:

https://wolfram.com/xid/0e7p5nb2-g6uach

Return the entity corresponding to the complement graph:

https://wolfram.com/xid/0e7p5nb2-o4jzfv

Show the graph names for the complement of graphs on four or fewer vertices:

https://wolfram.com/xid/0e7p5nb2-n2gmr2

The complement graph name of a self-complementary graph is identical to the StandardName:

https://wolfram.com/xid/0e7p5nb2-rt8dgf

Show graph and complement names (should be the same) for "interesting" small self-complementary graphs:

https://wolfram.com/xid/0e7p5nb2-mhjcet

Return the connected components graph of the graph:

https://wolfram.com/xid/0e7p5nb2-ja3xnk

Do the same using the "Graph" annotation:

https://wolfram.com/xid/0e7p5nb2-nxpwgd

Return the indices of the connected components:

https://wolfram.com/xid/0e7p5nb2-g7b2gk


https://wolfram.com/xid/0e7p5nb2-099onh

Return the names of the connected components:

https://wolfram.com/xid/0e7p5nb2-57t5hn

Return the number of connected components:

https://wolfram.com/xid/0e7p5nb2-xwuci0

Do the same using the "Count" annotation:

https://wolfram.com/xid/0e7p5nb2-rw4ep6

Give the vertex counts of the connected components:

https://wolfram.com/xid/0e7p5nb2-cu622c

Do the same using the "List" annotation:

https://wolfram.com/xid/0e7p5nb2-po6dnk

Do the same using the "VertexCount" annotation:

https://wolfram.com/xid/0e7p5nb2-ckd1y4


https://wolfram.com/xid/0e7p5nb2-yjhavr

Do the same using the "Graph" annotation:

https://wolfram.com/xid/0e7p5nb2-6uwev

Get the names of the coresistance graphs:

https://wolfram.com/xid/0e7p5nb2-hpk1eh

Show the graph and its coresistance graph together:

https://wolfram.com/xid/0e7p5nb2-ehju7u

Verify that the graphs in question have the same resistance sets:

https://wolfram.com/xid/0e7p5nb2-6hejf1

Show graphs that share a resistance multiset with at least one other distinct graph:

https://wolfram.com/xid/0e7p5nb2-fkm90r

List the names of graphs sharing the same multiset of resistances with a given graph:

https://wolfram.com/xid/0e7p5nb2-u0ug0s


https://wolfram.com/xid/0e7p5nb2-19uyjs

Show graph names for graphs that are equivalent with a particular 20-vertex graph:

https://wolfram.com/xid/0e7p5nb2-divg51


https://wolfram.com/xid/0e7p5nb2-fds6q0


https://wolfram.com/xid/0e7p5nb2-n9i0pw

Return the cospectral graphs of the tesseract graph using the default output type:

https://wolfram.com/xid/0e7p5nb2-2cntp2

Return the cospectral graphs of the tesseract graph explicitly as a graph:

https://wolfram.com/xid/0e7p5nb2-xqt5pi


https://wolfram.com/xid/0e7p5nb2-d2geqp


https://wolfram.com/xid/0e7p5nb2-cneplv


https://wolfram.com/xid/0e7p5nb2-lkr2io


https://wolfram.com/xid/0e7p5nb2-b8itjm

Give the names of graphs cospectral with the Shrikhande graph:

https://wolfram.com/xid/0e7p5nb2-eheqz3

Show graph names for graphs that are cospectral with the tesseract graph:

https://wolfram.com/xid/0e7p5nb2-kpq5ha


https://wolfram.com/xid/0e7p5nb2-lxlo6c


https://wolfram.com/xid/0e7p5nb2-l1l34d

Return a graph object for the cube graph of the 7-antiprism graph:

https://wolfram.com/xid/0e7p5nb2-eyi5uy

Compare with an explicit computation:

https://wolfram.com/xid/0e7p5nb2-86zka5


https://wolfram.com/xid/0e7p5nb2-csvzwy


https://wolfram.com/xid/0e7p5nb2-mnpa58

Return a graph object for the dual graph of the icosahedral graph:

https://wolfram.com/xid/0e7p5nb2-3ku1er


https://wolfram.com/xid/0e7p5nb2-vno82z


https://wolfram.com/xid/0e7p5nb2-5wv6hv

Not all graphs have unique duals:

https://wolfram.com/xid/0e7p5nb2-5gqt97

Show the graph name for the graph that is dual to the icosahedral graph:

https://wolfram.com/xid/0e7p5nb2-xizb71

It is in turn dual to the icosahedral graph:

https://wolfram.com/xid/0e7p5nb2-edt99e

List graphs with a tabulated graph dual:

https://wolfram.com/xid/0e7p5nb2-2c0p56

Display the Johnson solid J8 skeleton:

https://wolfram.com/xid/0e7p5nb2-vc0ky8

Verify that it is dual to itself:

https://wolfram.com/xid/0e7p5nb2-n91em4

Tabulate cataloged self-dual graphs:

https://wolfram.com/xid/0e7p5nb2-h17eni

Return the Levi graph of the Desargues configuration graph:

https://wolfram.com/xid/0e7p5nb2-bmx77b

Return the name of the Levi graph of the Desargues configuration graph:

https://wolfram.com/xid/0e7p5nb2-o5126


https://wolfram.com/xid/0e7p5nb2-bmrbib

Visualize the Desargues configuration:

https://wolfram.com/xid/0e7p5nb2-b30iqs


https://wolfram.com/xid/0e7p5nb2-i78kft

Compute the Levi graph explicitly:

https://wolfram.com/xid/0e7p5nb2-fvwkh3

Return the line graph of the icosahedral graph:

https://wolfram.com/xid/0e7p5nb2-hkncqc

Return the name of the line graph:

https://wolfram.com/xid/0e7p5nb2-d1w9sm


https://wolfram.com/xid/0e7p5nb2-pb9k1p

Give the name of the line graph for the Petersen graph:

https://wolfram.com/xid/0e7p5nb2-d9v5mw


https://wolfram.com/xid/0e7p5nb2-rhviuf

Give the names of the line graphs of the Platonic graphs:

https://wolfram.com/xid/0e7p5nb2-1i4jue

Show the Platonic graphs and their line graphs:

https://wolfram.com/xid/0e7p5nb2-f2v0ix

Show the graph names for the line graphs of non-empty graphs on four or fewer vertices:

https://wolfram.com/xid/0e7p5nb2-lkz3gc

Taking the line graph twice does not in general give back the original graph:

https://wolfram.com/xid/0e7p5nb2-vtqk64


https://wolfram.com/xid/0e7p5nb2-p7mutk

The line graph of a graph is isomorphic to itself only for cycle graphs or unions of identical cycle graphs:

https://wolfram.com/xid/0e7p5nb2-9seo7e

Return the local graph of the Conway–Smith graph:

https://wolfram.com/xid/0e7p5nb2-yvcg6j

Return the name of the local graph:

https://wolfram.com/xid/0e7p5nb2-4gswn4


https://wolfram.com/xid/0e7p5nb2-wxq36z

Return the name of the ordinary line graph of the pentagram configuration:

https://wolfram.com/xid/0e7p5nb2-y0jq3x

Return the ordinary line graph of the pentagram configuration:

https://wolfram.com/xid/0e7p5nb2-ciodjr

Compute by finding the extraordinary lines of the pentagram configuration:

https://wolfram.com/xid/0e7p5nb2-dpb60m


https://wolfram.com/xid/0e7p5nb2-9e80h

Complement with all possible pairs of points to get the ordinary lines:

https://wolfram.com/xid/0e7p5nb2-wegc8c


https://wolfram.com/xid/0e7p5nb2-qefows
Build the ordinary line graph:

https://wolfram.com/xid/0e7p5nb2-gawdwv

Identify using ToEntity:

https://wolfram.com/xid/0e7p5nb2-t5xvge

Return polyhedra whose skeletons are isomorphic to the cubical graph using the default output type:

https://wolfram.com/xid/0e7p5nb2-5v4txt

Return explicitly as PolyhedronData standard names:

https://wolfram.com/xid/0e7p5nb2-vgetoz


https://wolfram.com/xid/0e7p5nb2-670gr3


https://wolfram.com/xid/0e7p5nb2-j7zw1b

Return the root graph of the icosahedral line graph:

https://wolfram.com/xid/0e7p5nb2-9fboe9

Return the name of the line graph:

https://wolfram.com/xid/0e7p5nb2-m9zl73


https://wolfram.com/xid/0e7p5nb2-v7oqyy

Return a graph object for the simplex graph of the complete graph K4:

https://wolfram.com/xid/0e7p5nb2-86gjdr


https://wolfram.com/xid/0e7p5nb2-4zg58g


https://wolfram.com/xid/0e7p5nb2-ovalxg

Return a graph object for the square graph of the 7-antiprism graph:

https://wolfram.com/xid/0e7p5nb2-kof05w

Compare with an explicit computation:

https://wolfram.com/xid/0e7p5nb2-48oog8


https://wolfram.com/xid/0e7p5nb2-n8qng7


https://wolfram.com/xid/0e7p5nb2-cm3n4l

Annotatable Properties Related to List-Type Output (10)
Give the adjacency matrix of the default embedding for the square graph:

https://wolfram.com/xid/0e7p5nb2-r0sn1l


https://wolfram.com/xid/0e7p5nb2-jgm57q

Give the number of possible adjacency matrices:

https://wolfram.com/xid/0e7p5nb2-ri2nie

Return the same using the "Count" annotation:

https://wolfram.com/xid/0e7p5nb2-1tl4jo

Give all possible adjacency matrices:

https://wolfram.com/xid/0e7p5nb2-n7evq6


https://wolfram.com/xid/0e7p5nb2-i89x2k

Give (undirected) cycles of the house graph:

https://wolfram.com/xid/0e7p5nb2-frtttr


https://wolfram.com/xid/0e7p5nb2-qzckbw

Do the same using the explicit "Undirected" annotation:

https://wolfram.com/xid/0e7p5nb2-6dxb24


https://wolfram.com/xid/0e7p5nb2-i1qjnk

Give count of undirected cycles:

https://wolfram.com/xid/0e7p5nb2-jksx1r

Compare with the direct property:

https://wolfram.com/xid/0e7p5nb2-1pbmlz

Return the edges of the octahedral graph:

https://wolfram.com/xid/0e7p5nb2-qcau7g


https://wolfram.com/xid/0e7p5nb2-irtr69


https://wolfram.com/xid/0e7p5nb2-wlwuuj

Verify the above agrees with the "EdgeCount" property:

https://wolfram.com/xid/0e7p5nb2-uka5oa

Return the edges as a set of rules, suitable for plotting in GraphPlot:

https://wolfram.com/xid/0e7p5nb2-ligjii


https://wolfram.com/xid/0e7p5nb2-ya5a8e

Return a graphic of the edges:

https://wolfram.com/xid/0e7p5nb2-lhztwk

Give (undirected) Eulerian cycles of the butterfly graph:

https://wolfram.com/xid/0e7p5nb2-u1gsbs


https://wolfram.com/xid/0e7p5nb2-bjo4yt

Compare with the output of FindEulerianCycle:

https://wolfram.com/xid/0e7p5nb2-d5oen7


https://wolfram.com/xid/0e7p5nb2-3aftxv

Do the same using the explicit "Undirected" annotation:

https://wolfram.com/xid/0e7p5nb2-7m2pgo


https://wolfram.com/xid/0e7p5nb2-861m67

Give count of undirected cycles:

https://wolfram.com/xid/0e7p5nb2-p4dqhx

Compare with the direct property:

https://wolfram.com/xid/0e7p5nb2-1uiwq

Give the faces of the octahedral graph:

https://wolfram.com/xid/0e7p5nb2-5qsbvv


https://wolfram.com/xid/0e7p5nb2-i0f2lo


https://wolfram.com/xid/0e7p5nb2-myam2

Verify the above agrees with the "FaceCount" property:

https://wolfram.com/xid/0e7p5nb2-t9pgva

Show the faces of the octahedral graph:

https://wolfram.com/xid/0e7p5nb2-89tt0w

Give (undirected) Hamiltonian cycles of the house X graph:

https://wolfram.com/xid/0e7p5nb2-s3ed0d


https://wolfram.com/xid/0e7p5nb2-fjcy0j

Do the same using the explicit "Undirected" annotation:

https://wolfram.com/xid/0e7p5nb2-s4awip

Give directed Hamiltonian cycles:

https://wolfram.com/xid/0e7p5nb2-vpyap8

Give count of undirected Hamiltonian cycles:

https://wolfram.com/xid/0e7p5nb2-pzfqn8

Compare with the direct property:

https://wolfram.com/xid/0e7p5nb2-gt4dbi

Give (undirected) Hamiltonian paths of the butterfly graph:

https://wolfram.com/xid/0e7p5nb2-wkc2a3


https://wolfram.com/xid/0e7p5nb2-6r4u2m

Do the same using the explicit "Undirected" annotation:

https://wolfram.com/xid/0e7p5nb2-3ixh5z

Give directed Hamiltonian paths:

https://wolfram.com/xid/0e7p5nb2-4z6i7s

Give count of undirected Hamiltonian paths:

https://wolfram.com/xid/0e7p5nb2-0wvbh7

Compare with the direct property:

https://wolfram.com/xid/0e7p5nb2-kd8n95

Give (undirected) Hamiltonian walks of the butterfly graph:

https://wolfram.com/xid/0e7p5nb2-y4iewt


https://wolfram.com/xid/0e7p5nb2-futzs4

Do the same using the explicit "Undirected" annotation:

https://wolfram.com/xid/0e7p5nb2-vitlds

Give directed Hamiltonian paths:

https://wolfram.com/xid/0e7p5nb2-zgkw96

Give count of undirected Hamiltonian paths:

https://wolfram.com/xid/0e7p5nb2-8tz0i7

Compare with the direct property:

https://wolfram.com/xid/0e7p5nb2-jbb4j

Give the vertex coordinates of the default embedding of the octahedral graph:

https://wolfram.com/xid/0e7p5nb2-o99774


https://wolfram.com/xid/0e7p5nb2-pj39uc

This is equivalent to the "Embeddings" property:

https://wolfram.com/xid/0e7p5nb2-4yn0et


https://wolfram.com/xid/0e7p5nb2-gzmemj

Return the vertices of the octahedral graph:

https://wolfram.com/xid/0e7p5nb2-qfpael


https://wolfram.com/xid/0e7p5nb2-pufhn2

Verify the above agrees with the "VertexCount" property:

https://wolfram.com/xid/0e7p5nb2-kj49yn

Annotatable Properties Related to Graph Display (7)
Give all tabulated embeddings of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-ncjdbu

Show classes for each embedding:

https://wolfram.com/xid/0e7p5nb2-6oh31m


https://wolfram.com/xid/0e7p5nb2-xoulqj

Return the primary embedding of a graph:

https://wolfram.com/xid/0e7p5nb2-xpex7o


https://wolfram.com/xid/0e7p5nb2-1bu0jy

Return all tabulated planar embeddings of the graph:

https://wolfram.com/xid/0e7p5nb2-omzesc


https://wolfram.com/xid/0e7p5nb2-yjzwey

Return all tabulated LCF embeddings of the graph:

https://wolfram.com/xid/0e7p5nb2-kojx5p


https://wolfram.com/xid/0e7p5nb2-d19hlq

Give all tabulated 3D embeddings of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-digie3

Show classes for each 3D embedding:

https://wolfram.com/xid/0e7p5nb2-uwao46

Return all tabulated Polyhedron embeddings of the graph:

https://wolfram.com/xid/0e7p5nb2-exsos0


https://wolfram.com/xid/0e7p5nb2-mq4grk

Return the cubical graph as a graph object:

https://wolfram.com/xid/0e7p5nb2-rv0spo


https://wolfram.com/xid/0e7p5nb2-9dcw7x

Return tabulated planar embeddings:

https://wolfram.com/xid/0e7p5nb2-hc9cwn

Return the cubical graph as a 3D graph object:

https://wolfram.com/xid/0e7p5nb2-3uxvaf


https://wolfram.com/xid/0e7p5nb2-xybi89

Return tabulated polyhedron embeddings:

https://wolfram.com/xid/0e7p5nb2-bpgizo

Return the cubical graph as a graphics object:

https://wolfram.com/xid/0e7p5nb2-b8pwrp


https://wolfram.com/xid/0e7p5nb2-wpc6ss

Return tabulated planar embeddings:

https://wolfram.com/xid/0e7p5nb2-mac8h5

Return the cubical graph as a 3D graph object:

https://wolfram.com/xid/0e7p5nb2-sek860


https://wolfram.com/xid/0e7p5nb2-w2aj6e

Return tabulated polyhedron embeddings as graphics objects:

https://wolfram.com/xid/0e7p5nb2-zkxz4b

Return an image of the primary embedding of a graph:

https://wolfram.com/xid/0e7p5nb2-hbymli


https://wolfram.com/xid/0e7p5nb2-0avyel

Give all cataloged embeddings of the octahedral graph:

https://wolfram.com/xid/0e7p5nb2-cv1fav

Show the three-dimensional embedding of the cubical graph as an image:

https://wolfram.com/xid/0e7p5nb2-nlol71


https://wolfram.com/xid/0e7p5nb2-glu44u

Give all cataloged 3D embeddings of the cubical graph as images:

https://wolfram.com/xid/0e7p5nb2-o9t89i

Properties Representing Graph Polynomials (43)
Display the characteristic polynomial of the Coxeter graph as a pure function:

https://wolfram.com/xid/0e7p5nb2-jxmzys

As a function of a variable x:

https://wolfram.com/xid/0e7p5nb2-rm2lat

Compare with the directly computed value:

https://wolfram.com/xid/0e7p5nb2-ehbqzq


https://wolfram.com/xid/0e7p5nb2-ujf6s2

Give the chordless cycle polynomial of the cubical graph as a pure function:

https://wolfram.com/xid/0e7p5nb2-earlge

Extract tallies by cycle length:

https://wolfram.com/xid/0e7p5nb2-zt33tj

Extract tallies by cycle length a different way:

https://wolfram.com/xid/0e7p5nb2-c051an

Compare with the tallies of chordless cycle lengths:

https://wolfram.com/xid/0e7p5nb2-lz803w

Give the chromatic polynomial of the cubical graph as a pure function:

https://wolfram.com/xid/0e7p5nb2-kozy30

As a function of a variable x:

https://wolfram.com/xid/0e7p5nb2-mu1ni5

The chromatic polynomial is a special case of the rank polynomial:

https://wolfram.com/xid/0e7p5nb2-7ic48i

Give the chromatic polynomial of the icosahedral graph in terms of a variable x:

https://wolfram.com/xid/0e7p5nb2-y2jus9

Give the clique polynomial of the utility graph as a pure function:

https://wolfram.com/xid/0e7p5nb2-6dax0u

Compare to the explicit cliques:

https://wolfram.com/xid/0e7p5nb2-dwb361


https://wolfram.com/xid/0e7p5nb2-t194ek

Give the complement chordless cycle polynomial of the circulant graph as a pure function:

https://wolfram.com/xid/0e7p5nb2-zbbuw

Extract tallies by cycle length:

https://wolfram.com/xid/0e7p5nb2-f7c6wr

Extract tallies by cycle length a different way:

https://wolfram.com/xid/0e7p5nb2-29utrj

Compare with the tallies of complement chordless cycle lengths:

https://wolfram.com/xid/0e7p5nb2-qkw7j1

Give the complement odd chordless cycle polynomial of the circulant graph as a pure function:

https://wolfram.com/xid/0e7p5nb2-ksxiu8

Extract tallies by cycle length:

https://wolfram.com/xid/0e7p5nb2-bburdp

Extract tallies by cycle length a different way:

https://wolfram.com/xid/0e7p5nb2-cgrqer

Compare with the tallies of complement odd chordless cycle lengths:

https://wolfram.com/xid/0e7p5nb2-kgw0rc

Give the coboundary polynomial of the complete graph K5 as a pure function:

https://wolfram.com/xid/0e7p5nb2-cv4wa2

As a function of a variables q and t:

https://wolfram.com/xid/0e7p5nb2-f3xbkg

The coboundary polynomial is a special case of the Tutte polynomial:

https://wolfram.com/xid/0e7p5nb2-ik622d

Give the connected domination polynomial of the fish graph:

https://wolfram.com/xid/0e7p5nb2-ployvu

Compare with the connected dominating set count:

https://wolfram.com/xid/0e7p5nb2-7mgh8q


https://wolfram.com/xid/0e7p5nb2-d0lwds

Compare with connected dominating set tallies:

https://wolfram.com/xid/0e7p5nb2-jww2rf


https://wolfram.com/xid/0e7p5nb2-pae8wt

Give the connected induced subgraph polynomial of the Eiffel Tower graph:

https://wolfram.com/xid/0e7p5nb2-up5r24

Compare with the count of connected induced subgraphs:

https://wolfram.com/xid/0e7p5nb2-jkrwmu


https://wolfram.com/xid/0e7p5nb2-pshboi

Give the cycle polynomial of the cubical graph as a pure function:

https://wolfram.com/xid/0e7p5nb2-o3vlfg


https://wolfram.com/xid/0e7p5nb2-2bzt53


https://wolfram.com/xid/0e7p5nb2-okqzdh

Give the detour polynomial of the cubical graph as a pure function:

https://wolfram.com/xid/0e7p5nb2-ir2ibe

As a function of a variable x:

https://wolfram.com/xid/0e7p5nb2-tux3ab

Give the distance polynomial of the cubical graph as a pure function:

https://wolfram.com/xid/0e7p5nb2-l5yqsh

As a function of a variable x:

https://wolfram.com/xid/0e7p5nb2-slm1r3


https://wolfram.com/xid/0e7p5nb2-rqmjm5

Give the domination polynomial of the Coxeter graph as a pure function:

https://wolfram.com/xid/0e7p5nb2-j22uf7

As a function of a variable x:

https://wolfram.com/xid/0e7p5nb2-srrmh9

Give the edge cover polynomial of the utility graph as a pure function:

https://wolfram.com/xid/0e7p5nb2-e4w8qm

As a function of a variable x:

https://wolfram.com/xid/0e7p5nb2-o8302v

Compare to the explicit covers:

https://wolfram.com/xid/0e7p5nb2-bcb6m4

Give the edge cut polynomial of the utility graph as a pure function:

https://wolfram.com/xid/0e7p5nb2-kggh31

As a function of a variable x:

https://wolfram.com/xid/0e7p5nb2-74w9y2


https://wolfram.com/xid/0e7p5nb2-kjk2he

Give the flow polynomial of the cubical graph as a function of a variable u:

https://wolfram.com/xid/0e7p5nb2-enoc84

The flow polynomial is a special case of the rank polynomial:

https://wolfram.com/xid/0e7p5nb2-hu1vdl

Give the idiosyncratic polynomial of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-4vj9hf

Compare with a direct computation:

https://wolfram.com/xid/0e7p5nb2-mlq9yt

Give the independence polynomial of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-0cwj4c

Give the irredundance polynomial of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-8gs3on

Compute from the irredundant sets:

https://wolfram.com/xid/0e7p5nb2-cuwogc

Give the Laplacian polynomial of the cubical graph as a pure function:

https://wolfram.com/xid/0e7p5nb2-qnsizq

As a function of a variable x:

https://wolfram.com/xid/0e7p5nb2-j0jupi

Compute from Laplacian polynomial:

https://wolfram.com/xid/0e7p5nb2-frictb

Give the matching generating polynomial of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-q4iq25

Give the matching polynomial of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-6j4zmu

Give the maximal clique polynomial of the house graph as a pure function:

https://wolfram.com/xid/0e7p5nb2-575ixy

Extract tallies by maximal clique size:

https://wolfram.com/xid/0e7p5nb2-qc12vr

Extract tallies by maximal clique size a different way:

https://wolfram.com/xid/0e7p5nb2-s6tpuz

Compare with the tallies of maximal clique sizes:

https://wolfram.com/xid/0e7p5nb2-h77u4o

Give the maximal independence polynomial of the cricket graph as a pure function:

https://wolfram.com/xid/0e7p5nb2-bhxg3d

Extract tallies by maximal independent vertex set size:

https://wolfram.com/xid/0e7p5nb2-wntcfi

Extract tallies by maximal independent vertex set size a different way:

https://wolfram.com/xid/0e7p5nb2-so7mtw

Compare with the tallies of maximal independent edge sets:

https://wolfram.com/xid/0e7p5nb2-cqnoqd

Give the maximal irredundance polynomial of the cricket graph as a pure function:

https://wolfram.com/xid/0e7p5nb2-zgi5hk

Extract tallies by maximal irredundant set size:

https://wolfram.com/xid/0e7p5nb2-bj7ndy

Extract tallies by maximal irredundant set size a different way:

https://wolfram.com/xid/0e7p5nb2-58aeyj

Compare with the tallies of maximal irredundant sets:

https://wolfram.com/xid/0e7p5nb2-484uuq

Give the maximal matching generating polynomial of the cricket graph as a pure function:

https://wolfram.com/xid/0e7p5nb2-m33kzd

Extract tallies by maximal independent edge set size:

https://wolfram.com/xid/0e7p5nb2-0v1ixh

Extract tallies by maximal independent edge set size a different way:

https://wolfram.com/xid/0e7p5nb2-cg59w0

Compare with the tallies of maximal independent edge sets:

https://wolfram.com/xid/0e7p5nb2-b4cv49

Give the minimal connected domination polynomial of the 5-wheel graph as a pure function:

https://wolfram.com/xid/0e7p5nb2-ij7odo

Extract tallies by minimal connected dominating set size:

https://wolfram.com/xid/0e7p5nb2-odbmp4

Extract tallies by minimal connected dominating set size a different way:

https://wolfram.com/xid/0e7p5nb2-l6b1kp

Compare with the tallies of minimal connected dominating sets:

https://wolfram.com/xid/0e7p5nb2-w09b9f

Give the minimal domination polynomial of the cricket graph as a pure function:

https://wolfram.com/xid/0e7p5nb2-31chqo

Extract tallies by minimal dominating set size:

https://wolfram.com/xid/0e7p5nb2-tyzl5y

Extract tallies by minimal dominating set size a different way:

https://wolfram.com/xid/0e7p5nb2-4flbuv

Compare with the tallies of minimal dominating sets:

https://wolfram.com/xid/0e7p5nb2-2u62ms

Give the minimal edge cover polynomial of the cricket graph as a pure function:

https://wolfram.com/xid/0e7p5nb2-ch2ii8

Extract tallies by minimal edge cover size:

https://wolfram.com/xid/0e7p5nb2-mtq840

Extract tallies by minimal edge cover size a different way:

https://wolfram.com/xid/0e7p5nb2-23zay8

Compare with the tallies of minimal edge covers:

https://wolfram.com/xid/0e7p5nb2-v1gkmc

Give the minimal edge cut polynomial of the utility graph as a pure function:

https://wolfram.com/xid/0e7p5nb2-pzcb4e

As a function of a variable x:

https://wolfram.com/xid/0e7p5nb2-c58zmz


https://wolfram.com/xid/0e7p5nb2-6ykslw

Give the minimal total domination polynomial of the butterfly graph as a pure function:

https://wolfram.com/xid/0e7p5nb2-7raqdv

Extract tallies by total dominating set size:

https://wolfram.com/xid/0e7p5nb2-jk80qd

Extract tallies by total dominating set size a different way:

https://wolfram.com/xid/0e7p5nb2-vaa53i

Compare with the tallies of total dominating sets:

https://wolfram.com/xid/0e7p5nb2-qo94qi

Give the minimal vertex cover polynomial of the cricket graph as a pure function:

https://wolfram.com/xid/0e7p5nb2-7vh4kb

Extract tallies by minimal vertex cover size:

https://wolfram.com/xid/0e7p5nb2-cw28ng

Extract tallies by minimal vertex cover size a different way:

https://wolfram.com/xid/0e7p5nb2-6rss3d

Compare with the tallies of minimal vertex covers:

https://wolfram.com/xid/0e7p5nb2-pnizfq

Give the minimal vertex cut polynomial of the utility graph as a pure function:

https://wolfram.com/xid/0e7p5nb2-9sry2x

As a function of a variable x:

https://wolfram.com/xid/0e7p5nb2-n7k520


https://wolfram.com/xid/0e7p5nb2-6498ou

Give the odd chordless cycle polynomial of the Golomb graph as a pure function:

https://wolfram.com/xid/0e7p5nb2-qf3dii

Extract tallies by odd chordless cycle lengths:

https://wolfram.com/xid/0e7p5nb2-6g8e87

Extract tallies by odd chordless cycle lengths in a different way:

https://wolfram.com/xid/0e7p5nb2-c4si3b

Compare with the tallies of odd chordless cycle lengths:

https://wolfram.com/xid/0e7p5nb2-uvwmme

Give the path polynomial of the cubical graph as a pure function:

https://wolfram.com/xid/0e7p5nb2-jvq1t4


https://wolfram.com/xid/0e7p5nb2-ff579q


https://wolfram.com/xid/0e7p5nb2-ogkydb

Give the Q-chromatic polynomial of the Chvátal graph:

https://wolfram.com/xid/0e7p5nb2-rlz0k1

Give the rank polynomial of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-62c8x8

Give the reliability polynomial of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-wq45k6

The reliability polynomial is a special case of the Tutte polynomial:

https://wolfram.com/xid/0e7p5nb2-zudrs8

Give the sigma polynomial of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-1sa94v

Give the total domination polynomial of the 5-wheel graph as a pure function:

https://wolfram.com/xid/0e7p5nb2-76k8sf

Extract tallies by total dominating set size:

https://wolfram.com/xid/0e7p5nb2-pin01

Extract tallies by total dominating set size a different way:

https://wolfram.com/xid/0e7p5nb2-dmw259

Compare with the tallies of total dominating sets:

https://wolfram.com/xid/0e7p5nb2-i67c1e

Give the Tutte polynomial of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-isbl76

The Tutte polynomial is a special case of the rank polynomial:

https://wolfram.com/xid/0e7p5nb2-ewscza

Give the vertex cover polynomial of the utility graph as a pure function:

https://wolfram.com/xid/0e7p5nb2-pn1ou2

Compare to the explicit covers:

https://wolfram.com/xid/0e7p5nb2-ernh1h


https://wolfram.com/xid/0e7p5nb2-h03t4w

Give the vertex cut polynomial of the utility graph as a pure function:

https://wolfram.com/xid/0e7p5nb2-nj7i7h

As a function of a variable x:

https://wolfram.com/xid/0e7p5nb2-udya5e


https://wolfram.com/xid/0e7p5nb2-e6q265

Coloring-Related Graph Properties (13)
Give the chromatic invariant cubical graph:

https://wolfram.com/xid/0e7p5nb2-23tfzt

Give the chromatic number of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-cx8fan

Compare with the built-in function:

https://wolfram.com/xid/0e7p5nb2-6lzjn

Visualize the chromatic number:

https://wolfram.com/xid/0e7p5nb2-3r6ux9


https://wolfram.com/xid/0e7p5nb2-sgvei4

Give the edge chromatic number of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-8jaeqg

Compare with the built-in function:

https://wolfram.com/xid/0e7p5nb2-44zawc

Visualize the edge chromatic number:

https://wolfram.com/xid/0e7p5nb2-qsmqm3


https://wolfram.com/xid/0e7p5nb2-3tfmv9

Give the fractional chromatic numbers of the Mycielski graphs:

https://wolfram.com/xid/0e7p5nb2-knxsm7

Compare with the closed form known for this fractional chromatic number:

https://wolfram.com/xid/0e7p5nb2-3z3r70

Return the chromatic roots of the first Harvey–Royle graph:

https://wolfram.com/xid/0e7p5nb2-jhzwlt

Verify equality with the roots of the chromatic polynomial:

https://wolfram.com/xid/0e7p5nb2-t6odgc

Return the cyclic chromatic number of of 2-Plummer–Toft graph:

https://wolfram.com/xid/0e7p5nb2-g7d7d4

Give the fractional edge chromatic numbers of the flower snark :

https://wolfram.com/xid/0e7p5nb2-9r93k4

Give a minimum edge coloring of the octahedral graph:

https://wolfram.com/xid/0e7p5nb2-gjw16l


https://wolfram.com/xid/0e7p5nb2-bhcret


https://wolfram.com/xid/0e7p5nb2-odrbau

Give the number of minimum vertex colorings of the octahedral graph:

https://wolfram.com/xid/0e7p5nb2-jotl5m

Do the same using an annotation:

https://wolfram.com/xid/0e7p5nb2-6vmdoj

Compare with the number of actual colorings:

https://wolfram.com/xid/0e7p5nb2-8fqwkx

Give the minimum vertex colorings of the octahedral graph:

https://wolfram.com/xid/0e7p5nb2-mspech

Verify the colorings are consistent with the chromatic number:

https://wolfram.com/xid/0e7p5nb2-vm3wh4


https://wolfram.com/xid/0e7p5nb2-89nteg


https://wolfram.com/xid/0e7p5nb2-c7lwah

Show a minimum-weight fractional coloring of the Petersen graph:

https://wolfram.com/xid/0e7p5nb2-7mvdeu

Compute the fractional chromatic number:

https://wolfram.com/xid/0e7p5nb2-rmy4um

Compare with the direct property:

https://wolfram.com/xid/0e7p5nb2-jj3ibu

Give the Q-chromatic polynomial of the Chvátal graph:

https://wolfram.com/xid/0e7p5nb2-heuc2s

The Q-chromatic polynomial has smaller degree and coefficients than the usual chromatic polynomial for graphs with chromatic number at least 3:

https://wolfram.com/xid/0e7p5nb2-haxg9r


https://wolfram.com/xid/0e7p5nb2-38a29f

The Q-chromatic polynomial is not defined for graphs with chromatic number less than 3:

https://wolfram.com/xid/0e7p5nb2-c2h6e5


https://wolfram.com/xid/0e7p5nb2-ek9k7o

Give the Weisfeiler–Leman dimension of the tetrahedral graph:

https://wolfram.com/xid/0e7p5nb2-u4hc6a

Graph Index Properties (18)
Give the ABC index of the butane graph:

https://wolfram.com/xid/0e7p5nb2-3hy5ws

Compare with the sum of ABC matrix elements:

https://wolfram.com/xid/0e7p5nb2-7yjrhz

Give the arithmetic-geometric index of the propane graph:

https://wolfram.com/xid/0e7p5nb2-czyfiv

Compare with the sum of arithmetic-geometric matrix elements:

https://wolfram.com/xid/0e7p5nb2-4evd5r

Display the Balaban index of the Coxeter graph:

https://wolfram.com/xid/0e7p5nb2-0zk564

Give the Balaban index of the isobutane graph:

https://wolfram.com/xid/0e7p5nb2-ji1im0

Give the circuit rank of the Coxeter graph:

https://wolfram.com/xid/0e7p5nb2-wnl1zx

Display the circuit rank of the icosahedral graph:

https://wolfram.com/xid/0e7p5nb2-e3upow

Compare with the value obtained from other properties:

https://wolfram.com/xid/0e7p5nb2-lsofe7

Give the detour index of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-5n9itd

Give the Harary index of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-fpkd9q

Give the Hosoya index of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-5a91ap

The Hosoya index is identical to the independent edge set count:

https://wolfram.com/xid/0e7p5nb2-copbc4

Give the Kirchhoff index of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-lf9sfs

Give the Kirchhoff index of the isobutane graph:

https://wolfram.com/xid/0e7p5nb2-ckhb2n

Give the Kirchhoff sum index of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-mcgbgq

Give the Kirchhoff sum index of the isobutane graph:

https://wolfram.com/xid/0e7p5nb2-2cvpb2

Give the molecular topological index of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-joqrhs

Give the stability index of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-c8cg7k

Give the Randić index of the octahedral graph:

https://wolfram.com/xid/0e7p5nb2-x2yrkp

Compare with the sum of Randić matrix elements:

https://wolfram.com/xid/0e7p5nb2-wg2l6z

Give the Sombor index of the octahedral graph:

https://wolfram.com/xid/0e7p5nb2-rhwhv8

Compare with the sum of Sombor matrix elements:

https://wolfram.com/xid/0e7p5nb2-t1cw8n

Give the topological index of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-kutyqx

Give the Wiener index of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-setrl4

Give the Wiener index of the isobutane graph:

https://wolfram.com/xid/0e7p5nb2-uocnq4

Give the Wiener sum index of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-f7vqvz

Give the Wiener sum index of the isobutane graph:

https://wolfram.com/xid/0e7p5nb2-ibpsdu

Give the first Zagreb index of the cubic graph:

https://wolfram.com/xid/0e7p5nb2-8gmbyg

The first Zagreb index is defined as the sum of squared vertex degrees:

https://wolfram.com/xid/0e7p5nb2-1mpw2c

Give the second Zagreb index of the cubic graph:

https://wolfram.com/xid/0e7p5nb2-9pvrct

The second Zagreb index is defined as the sum of squared vertex degrees:

https://wolfram.com/xid/0e7p5nb2-7itn0p

https://wolfram.com/xid/0e7p5nb2-9ji174

Matrix Graph Properties (12)
Give the ABC matrix of the propane graph:

https://wolfram.com/xid/0e7p5nb2-omxnxj

Give the arithmetic-geometric matrix of the propane graph:

https://wolfram.com/xid/0e7p5nb2-06a30f

Give the adjacency matrix, returned as a SparseArray object:

https://wolfram.com/xid/0e7p5nb2-5cvaaa

Convert to an explicit matrix:

https://wolfram.com/xid/0e7p5nb2-5s79cr


https://wolfram.com/xid/0e7p5nb2-gqhbnr

Plot the matrix using ArrayPlot:

https://wolfram.com/xid/0e7p5nb2-ofhaou

Verify that the positions of 1s in the adjacency matrix correspond to graph edges:

https://wolfram.com/xid/0e7p5nb2-d9nqbk


https://wolfram.com/xid/0e7p5nb2-g1op4a


https://wolfram.com/xid/0e7p5nb2-d8uid4

Give the detour matrix of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-m17h8a

Return the distance matrix of the octahedral graph:

https://wolfram.com/xid/0e7p5nb2-6lri5i


https://wolfram.com/xid/0e7p5nb2-8h0fnx


https://wolfram.com/xid/0e7p5nb2-wbzuy8

Give the incidence matrix of the octahedral graph:

https://wolfram.com/xid/0e7p5nb2-r60me3


https://wolfram.com/xid/0e7p5nb2-ralb2s


https://wolfram.com/xid/0e7p5nb2-bbgtbq

Give the Laplacian matrix of the octahedral graph:

https://wolfram.com/xid/0e7p5nb2-vd5q3


https://wolfram.com/xid/0e7p5nb2-1h820q


https://wolfram.com/xid/0e7p5nb2-1gxfly

Show the maximum flow matrix for the E graph:

https://wolfram.com/xid/0e7p5nb2-tm0urf

Show the minimum cost flow matrix for the E graph:

https://wolfram.com/xid/0e7p5nb2-d7rgtn

Give the normalized Laplacian matrix of the octahedral graph:

https://wolfram.com/xid/0e7p5nb2-8c6owr

Give the matrix in expanded form:

https://wolfram.com/xid/0e7p5nb2-fks4un


https://wolfram.com/xid/0e7p5nb2-cpqg98

Give the Randić matrix of the propane graph:

https://wolfram.com/xid/0e7p5nb2-q86ta4

Give the resistance matrix of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-jszi3y


https://wolfram.com/xid/0e7p5nb2-nftkcu


https://wolfram.com/xid/0e7p5nb2-dyryyz

Give the Sombor matrix of the propane graph:

https://wolfram.com/xid/0e7p5nb2-ix74n8

Local Graph Properties (6)

https://wolfram.com/xid/0e7p5nb2-evtx3c

List the bridges of the Walther graph:

https://wolfram.com/xid/0e7p5nb2-gqqyh0


https://wolfram.com/xid/0e7p5nb2-h294fu


https://wolfram.com/xid/0e7p5nb2-qe4khl

Do the same using the "Count" annotation:

https://wolfram.com/xid/0e7p5nb2-sikmwl

Give the number of chords in the house graph:

https://wolfram.com/xid/0e7p5nb2-s8eioh


https://wolfram.com/xid/0e7p5nb2-svmy9e

List the chords of the house graph:

https://wolfram.com/xid/0e7p5nb2-xdwei8


https://wolfram.com/xid/0e7p5nb2-5hls5f


https://wolfram.com/xid/0e7p5nb2-oq087t

Do the same using the "Count" annotation:

https://wolfram.com/xid/0e7p5nb2-1vuzah

Display the curvatures of the A graph:

https://wolfram.com/xid/0e7p5nb2-lae6ts


https://wolfram.com/xid/0e7p5nb2-w4t2r6


https://wolfram.com/xid/0e7p5nb2-t0622n


https://wolfram.com/xid/0e7p5nb2-c43wnc


https://wolfram.com/xid/0e7p5nb2-181nnn

Show number of leaves directly:

https://wolfram.com/xid/0e7p5nb2-0bah5g

Do the same using the "Count" annotation:

https://wolfram.com/xid/0e7p5nb2-07z4bg


https://wolfram.com/xid/0e7p5nb2-li09kt

Global Graph Properties (29)
Show the anarboricity of the cycle graph :

https://wolfram.com/xid/0e7p5nb2-7s8516

Give the number of apices of the Wagner graph:

https://wolfram.com/xid/0e7p5nb2-y69a9e


https://wolfram.com/xid/0e7p5nb2-p8qco

Compare with the length of the list of apices:

https://wolfram.com/xid/0e7p5nb2-z7lzye

List named connected (nonplanar) apex graphs:

https://wolfram.com/xid/0e7p5nb2-oxm9up

Find all apices of the Wagner graph:

https://wolfram.com/xid/0e7p5nb2-h5l64s


https://wolfram.com/xid/0e7p5nb2-6dujd3


https://wolfram.com/xid/0e7p5nb2-ntw4we

Delete apices and verify planarity of the resulting graphs:

https://wolfram.com/xid/0e7p5nb2-bwvq2l


https://wolfram.com/xid/0e7p5nb2-jsm53u

Show the arboricity of the complete graphs:

https://wolfram.com/xid/0e7p5nb2-v9r97b

Compare with the value form theory:

https://wolfram.com/xid/0e7p5nb2-srd713

Give the number of articulation vertices in the A-graph:

https://wolfram.com/xid/0e7p5nb2-9mow9m

Compare with the list of articulation vertices:

https://wolfram.com/xid/0e7p5nb2-lfj85l


https://wolfram.com/xid/0e7p5nb2-0levas

Find graphs having articulation vertices:

https://wolfram.com/xid/0e7p5nb2-60xmkd

Give the indices of the articulation vertices of the isobutane graph:

https://wolfram.com/xid/0e7p5nb2-1p7iyy

Visualize the articulation vertices:

https://wolfram.com/xid/0e7p5nb2-qojtoo


https://wolfram.com/xid/0e7p5nb2-ivav62


https://wolfram.com/xid/0e7p5nb2-zyxgjw

Display the circumference of the icosahedral graph:

https://wolfram.com/xid/0e7p5nb2-mzk35b

Verify that this corresponds to the length of the longest cycle:

https://wolfram.com/xid/0e7p5nb2-rj9x0h


https://wolfram.com/xid/0e7p5nb2-zo3fvz

Display the corank of the icosahedral graph:

https://wolfram.com/xid/0e7p5nb2-lq81kj

Compute the corank from other graph properties:

https://wolfram.com/xid/0e7p5nb2-9f9sgw

Give the graphs on four or fewer vertices that are determined by resistance:

https://wolfram.com/xid/0e7p5nb2-kva5l6

Check if the cubical graph is determined by spectrum:

https://wolfram.com/xid/0e7p5nb2-jvt0mj

Check if the tesseract graph is determined by spectrum:

https://wolfram.com/xid/0e7p5nb2-2icxyd

Give the names of the graphs with the same spectrum as the tesseract graph:

https://wolfram.com/xid/0e7p5nb2-f6z61g

Give the diameter of the Pappus graph:

https://wolfram.com/xid/0e7p5nb2-73rwyy

Give the eccentricities of the Pappus graph:

https://wolfram.com/xid/0e7p5nb2-jijkyn

Give the intersection array of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-8gkn2k

Display the maximum leaf number of the A graph:

https://wolfram.com/xid/0e7p5nb2-cm2jy2

The maximum leaf number is the maximum possible leaf count of a spanning tree:

https://wolfram.com/xid/0e7p5nb2-hc2x86


https://wolfram.com/xid/0e7p5nb2-qq4a39


https://wolfram.com/xid/0e7p5nb2-zwi15l

Give the maximum vertex degree of the E graph:

https://wolfram.com/xid/0e7p5nb2-fpveeq


https://wolfram.com/xid/0e7p5nb2-clc4tb


https://wolfram.com/xid/0e7p5nb2-71tpz


https://wolfram.com/xid/0e7p5nb2-f23zgg


https://wolfram.com/xid/0e7p5nb2-ldu3hf


https://wolfram.com/xid/0e7p5nb2-smwl39

Display the mean curvature of the A graph:

https://wolfram.com/xid/0e7p5nb2-xonkhc

The mean curvature is the mean of the curvatures associated with individual vertices:

https://wolfram.com/xid/0e7p5nb2-bry1rd

Display the mean distance of the Petersen graph:

https://wolfram.com/xid/0e7p5nb2-lluo1c

Display the minimum leaf number of the A graph:

https://wolfram.com/xid/0e7p5nb2-lgk1s3

The maximum leaf number is the minimum possible leaf count of a spanning tree:

https://wolfram.com/xid/0e7p5nb2-0ngn7


https://wolfram.com/xid/0e7p5nb2-ok3qym


https://wolfram.com/xid/0e7p5nb2-vemzxz

Give the minimum vertex degree of the E graph:

https://wolfram.com/xid/0e7p5nb2-t5ccoo


https://wolfram.com/xid/0e7p5nb2-irx2iv


https://wolfram.com/xid/0e7p5nb2-p8n731


https://wolfram.com/xid/0e7p5nb2-xxh9u7


https://wolfram.com/xid/0e7p5nb2-kwx2jw


https://wolfram.com/xid/0e7p5nb2-j9lbai

Display the periphery of a tree:

https://wolfram.com/xid/0e7p5nb2-6ehx8i


https://wolfram.com/xid/0e7p5nb2-tolk1q

Display the quadratic embedding constant of the icosahedral graph:

https://wolfram.com/xid/0e7p5nb2-5nahgn

For graphs whose distance matrices have constant row sums, the quadratic embedding constant equals the second largest eigenvalue of the distance matrix:

https://wolfram.com/xid/0e7p5nb2-meg5yl


https://wolfram.com/xid/0e7p5nb2-nfufq8

Display the rank of the icosahedral graph:

https://wolfram.com/xid/0e7p5nb2-3eh2zy

Compute the rank from other graph properties:

https://wolfram.com/xid/0e7p5nb2-7w6eas

Display the regular parameters of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-mdkqrb

Display the skewness of the tesseract graph:

https://wolfram.com/xid/0e7p5nb2-okiqrm

Compare with the result from theory:

https://wolfram.com/xid/0e7p5nb2-virmf5

Display the number of spanning trees in the 120-cell graph:

https://wolfram.com/xid/0e7p5nb2-opa520

Show the triameter of the Coxeter graph:

https://wolfram.com/xid/0e7p5nb2-72pe5

Compare with the directly computed value:

https://wolfram.com/xid/0e7p5nb2-krsq6p

Show the vertex degrees of the claw graph:

https://wolfram.com/xid/0e7p5nb2-nm3izs


https://wolfram.com/xid/0e7p5nb2-xm3nu2

Give the toroidal crossing numbers for complete graphs:

https://wolfram.com/xid/0e7p5nb2-ni27g0

Spectral Graph Properties (13)
Give the ABC energy of isobutane:

https://wolfram.com/xid/0e7p5nb2-ndnl03

Compare with the sum of absolute values of the eigenvalue of the ABC matrix:

https://wolfram.com/xid/0e7p5nb2-twgs1y

Give the ABC spectral radius of isobutane:

https://wolfram.com/xid/0e7p5nb2-tn3ghm

Compare with the largest eigenvalue of the ABC matrix:

https://wolfram.com/xid/0e7p5nb2-y4m1at

Give the algebraic connectivity of isobutane:

https://wolfram.com/xid/0e7p5nb2-mtgbhb

Algebraic connectivity is defined as the second smallest member of the Laplacian spectrum:

https://wolfram.com/xid/0e7p5nb2-5adw8e

Compare with the second smallest eigenvalue of the Laplacian matrix:

https://wolfram.com/xid/0e7p5nb2-eay39l

Give the arithmetic-geometric energy of methane:

https://wolfram.com/xid/0e7p5nb2-bu0gdn

Compare with the sum of absolute values of the eigenvalue of the arithmetic-geometric matrix:

https://wolfram.com/xid/0e7p5nb2-0989g9

Give the arithmetic-geometric spectral radius of isobutane:

https://wolfram.com/xid/0e7p5nb2-kn1of

Compare with the largest eigenvalue of the arithmetic-geometric matrix:

https://wolfram.com/xid/0e7p5nb2-b2pxtk

Display the Laplacian spectral radius of the tesseract graph:

https://wolfram.com/xid/0e7p5nb2-hfcwpv

The Laplacian spectral radius is the largest eigenvalue of the Kirchhoff matrix:

https://wolfram.com/xid/0e7p5nb2-joy06l

Display the Laplacian spectral ratio of the tesseract graph:

https://wolfram.com/xid/0e7p5nb2-pq5ifg

The Laplacian spectral ratio is defined as the ratio of the Laplacian spectral radius to the algebraic connectivity:

https://wolfram.com/xid/0e7p5nb2-pqj4s8

Display the Laplacian spectrum of the 600-cell graph:

https://wolfram.com/xid/0e7p5nb2-uae0yo

Display a nicely formatted version:

https://wolfram.com/xid/0e7p5nb2-muhysq

https://wolfram.com/xid/0e7p5nb2-q9f68y

Give the Randić energy of isobutane:

https://wolfram.com/xid/0e7p5nb2-hn2r7v

Compare with the sum of absolute values of the eigenvalue of the Randić matrix:

https://wolfram.com/xid/0e7p5nb2-ygbgtp

Give the Sombor energy of isobutane:

https://wolfram.com/xid/0e7p5nb2-f5uuo2

Compare with the sum of absolute values of the eigenvalue of the Sombor matrix:

https://wolfram.com/xid/0e7p5nb2-ft4ffk

Give the Sombor spectral radius of isobutane:

https://wolfram.com/xid/0e7p5nb2-bysqb9

Compare with the largest eigenvalue of the Sombor matrix:

https://wolfram.com/xid/0e7p5nb2-vy6xpx

Give the spectral radius of the 600-cell graph:

https://wolfram.com/xid/0e7p5nb2-5xt0n4

Compare with the graph spectrum:

https://wolfram.com/xid/0e7p5nb2-245xpw

Display the spectrum of the 600-cell graph:

https://wolfram.com/xid/0e7p5nb2-2vws8w

Display a nicely formatted version:

https://wolfram.com/xid/0e7p5nb2-dik3to

https://wolfram.com/xid/0e7p5nb2-mk8tmi

Labeled Graph Properties (11)
Return the average disorder number of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-lgdwy4

Compare with the Wiener index:

https://wolfram.com/xid/0e7p5nb2-f80z64

Return the disorder number of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-3defdv

Return the Erdős sequence of the 2-triangular grid graph:

https://wolfram.com/xid/0e7p5nb2-sms4ak

Construct the corresponding Erdős graph:

https://wolfram.com/xid/0e7p5nb2-r594l6


https://wolfram.com/xid/0e7p5nb2-gudj98

Return the number of fundamentally distinct graceful labelings for the tetrahedral graph:

https://wolfram.com/xid/0e7p5nb2-0a6x7v

Do the same using the "Count" annotation:

https://wolfram.com/xid/0e7p5nb2-u788d5

Compare with the number of distinct labelings:

https://wolfram.com/xid/0e7p5nb2-3ps1jo

Show the fundamentally distinct graceful labelings of the tetrahedral graph:

https://wolfram.com/xid/0e7p5nb2-glwl6v


https://wolfram.com/xid/0e7p5nb2-ko1za1

Verify the labeling is graceful:

https://wolfram.com/xid/0e7p5nb2-rxd2qc


https://wolfram.com/xid/0e7p5nb2-oev81e

Give the irregularity strength of the 5-star graph:

https://wolfram.com/xid/0e7p5nb2-kd9fje

Return the connected graphs for which the irregularity strength equals one less than the vertex count:

https://wolfram.com/xid/0e7p5nb2-nucg2b

Give the number of pinnacle sets in the banner graph:

https://wolfram.com/xid/0e7p5nb2-u19bv4

Do the same with the "Count" annotation:

https://wolfram.com/xid/0e7p5nb2-f60dz0

Compare with the length of actual sets:

https://wolfram.com/xid/0e7p5nb2-g4gu9q

Return the pinnacle sets of the banner graph:

https://wolfram.com/xid/0e7p5nb2-xb9xoj

Show labelings of the graph corresponding to these pinnacle sets:

https://wolfram.com/xid/0e7p5nb2-gsu7qo

https://wolfram.com/xid/0e7p5nb2-z9jfrr

https://wolfram.com/xid/0e7p5nb2-6soebt

Show the fundamentally distinct optimal radio labelings of the 5-path graph:

https://wolfram.com/xid/0e7p5nb2-z5yyr0


https://wolfram.com/xid/0e7p5nb2-m7b9tx

Return the number of fundamentally distinct optimal radio labelings for the 5-path graph:

https://wolfram.com/xid/0e7p5nb2-q4acuu

Do the same using the "Count" annotation:

https://wolfram.com/xid/0e7p5nb2-zp6r4d

Compare with the number of distinct optimal labelings:

https://wolfram.com/xid/0e7p5nb2-la530j

Give the radio number of the 5-path graph:

https://wolfram.com/xid/0e7p5nb2-e97b1b

Compare again the maximum label of all distinct optimal radio labelings:

https://wolfram.com/xid/0e7p5nb2-re4zza

Graph Construction Properties (2)
Display the assembly number of the pentatope graph:

https://wolfram.com/xid/0e7p5nb2-9sityi

Display the construction number of the pentatope graph:

https://wolfram.com/xid/0e7p5nb2-wrbzln

Topological Graph Properties (10)
Display the crossing number of the icosahedral graph:

https://wolfram.com/xid/0e7p5nb2-oo0qhz

The crossing number is 0 since the graph is planar:

https://wolfram.com/xid/0e7p5nb2-o78av6

Return the dimension of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-y0inur

Show unit-distance embeddings in the plane corresponding to dimension 2:

https://wolfram.com/xid/0e7p5nb2-2a2t0j

Give the genus of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-pr8x2h

Give the genus of the unique graph that triangulates the torus and Klein bottle:

https://wolfram.com/xid/0e7p5nb2-poisa1

Give the Klein bottle crossing number of the unique graph that triangulates the torus and Klein bottle:

https://wolfram.com/xid/0e7p5nb2-8gdgl3

Display the local crossing number of the complete graph K6:

https://wolfram.com/xid/0e7p5nb2-ppw5s9

Display embeddings with this number of crossings:

https://wolfram.com/xid/0e7p5nb2-iicu4v

The crossed dodecahedral graph has a unique 2-planar embedding, but does not admit a straight-line 2-planar drawing:

https://wolfram.com/xid/0e7p5nb2-pel3ib


https://wolfram.com/xid/0e7p5nb2-v9mkkx

Return the metric dimension of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-zxahvi

Give the projective plane crossing numbers of the complete bipartite graphs :

https://wolfram.com/xid/0e7p5nb2-fqapa6

Compare with the known closed-form values:

https://wolfram.com/xid/0e7p5nb2-9sdt7a

Give the rectilinear crossing numbers for complete graphs:

https://wolfram.com/xid/0e7p5nb2-b3f8fu

Display the rectilinear local crossing number of the complete graph K6:

https://wolfram.com/xid/0e7p5nb2-slzabs

Display embeddings with this number of rectilinear crossings:

https://wolfram.com/xid/0e7p5nb2-y3jnf4

Give the toroidal crossing number of the unique graph that triangulates the torus and Klein bottle:

https://wolfram.com/xid/0e7p5nb2-9hktx0

Clique‐Related Graph Properties (15)
Return the clique count of the octahedral graph:

https://wolfram.com/xid/0e7p5nb2-z3re74

Compare with the explicit listing of cliques:

https://wolfram.com/xid/0e7p5nb2-ofxck

Return the clique number of the icosahedral graph:

https://wolfram.com/xid/0e7p5nb2-y0qtz7

Compare with the lengths of the maximum cliques:

https://wolfram.com/xid/0e7p5nb2-pf4fh8


https://wolfram.com/xid/0e7p5nb2-n6w51r

Give the clique polynomial of the utility graph:

https://wolfram.com/xid/0e7p5nb2-zmqsvr

Compare to the explicit cliques:

https://wolfram.com/xid/0e7p5nb2-sryxht


https://wolfram.com/xid/0e7p5nb2-wa5uhl

Return the cliques of the octahedral graph:

https://wolfram.com/xid/0e7p5nb2-rvh26z

Return the Delsarte cliques of the octahedral graph:

https://wolfram.com/xid/0e7p5nb2-106tw9

Compare with number of cliques directly:

https://wolfram.com/xid/0e7p5nb2-6u3g2s

Return the Delsarte cliques of the octahedral graph:

https://wolfram.com/xid/0e7p5nb2-fivzbe

Verify the graph is distance-regular:

https://wolfram.com/xid/0e7p5nb2-3x9tui

Verify these cliques achieve the Delsarte bound:

https://wolfram.com/xid/0e7p5nb2-e3a1px

https://wolfram.com/xid/0e7p5nb2-fluu2u

Return the fractional clique number of the Heawood graph:

https://wolfram.com/xid/0e7p5nb2-x13jlm

Return the lower clique number of the Krackhardt kite graph:

https://wolfram.com/xid/0e7p5nb2-h5spn2

Compare with the size of the smallest maximal clique:

https://wolfram.com/xid/0e7p5nb2-lhc6tj


https://wolfram.com/xid/0e7p5nb2-m1zirm

Return the number of maximal cliques of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-imusgd

Compare with the number of maximal cliques:

https://wolfram.com/xid/0e7p5nb2-lz45g4


https://wolfram.com/xid/0e7p5nb2-za927d

Return the maximal clique polynomial of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-y1qkvj

Return the maximal cliques of the bull graph:

https://wolfram.com/xid/0e7p5nb2-s7756q

Return the maximum cliques of the bull graph:

https://wolfram.com/xid/0e7p5nb2-gb8yqt

Give the smallest covers of the cubical graph by maximal cliques:

https://wolfram.com/xid/0e7p5nb2-8sksjr


https://wolfram.com/xid/0e7p5nb2-2bdsml

Give the number of smallest covers of the cubical graph by maximal cliques:

https://wolfram.com/xid/0e7p5nb2-rd7lj5

Give the name of the simplex graph of the cycle graph C5, i.e. the graph with vertices given by the cliques of the base graph and edges between pairs of cliques that differ by insertion/deletion of exactly one vertex:

https://wolfram.com/xid/0e7p5nb2-822lvi


https://wolfram.com/xid/0e7p5nb2-rzt2qn

Cover‐Related Graph Properties (20)
Give the biclique cover of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-bmdqlo

Return the clique covering number of the icosahedral graph:

https://wolfram.com/xid/0e7p5nb2-tlj0wu

Verify it is the chromatic number of the graph complement:

https://wolfram.com/xid/0e7p5nb2-nh51go


https://wolfram.com/xid/0e7p5nb2-k73l6b

Give the number of edge covers of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-bolf89

Compare to the length of the list of edge covers:

https://wolfram.com/xid/0e7p5nb2-7wyx6a

Return the edge cover number of the icosahedral graph:

https://wolfram.com/xid/0e7p5nb2-ugadmm

Compare with the length of a minimum edge cover:

https://wolfram.com/xid/0e7p5nb2-861k0n


https://wolfram.com/xid/0e7p5nb2-dk8dnr

Give the edge cover polynomial of the utility graph:

https://wolfram.com/xid/0e7p5nb2-z6ep64

Compare to the explicit covers:

https://wolfram.com/xid/0e7p5nb2-2b5cgf


https://wolfram.com/xid/0e7p5nb2-s1qvuy

Give the edge covers of the utility graph:

https://wolfram.com/xid/0e7p5nb2-rpd5g

Return the number of minimal edge covers for the cubical graph:

https://wolfram.com/xid/0e7p5nb2-vbz4o3

Compare to the length of the list:

https://wolfram.com/xid/0e7p5nb2-5dbcww


https://wolfram.com/xid/0e7p5nb2-5yrucm

Return the minimal edge cover polynomial of the tetrahedral graph:

https://wolfram.com/xid/0e7p5nb2-o7vawk

Compute from the minimal edge covers:

https://wolfram.com/xid/0e7p5nb2-3rx269

Return the minimal edge covers of the tetrahedral graph:

https://wolfram.com/xid/0e7p5nb2-hfmvsx

Return the number of minimal vertex covers for the cubical graph:

https://wolfram.com/xid/0e7p5nb2-7hn00d

Compare to the length of the list:

https://wolfram.com/xid/0e7p5nb2-38zvgn


https://wolfram.com/xid/0e7p5nb2-mlslt

Return the minimal vertex cover polynomial of the tetrahedral graph:

https://wolfram.com/xid/0e7p5nb2-d2ajj

Compute from the minimal vertex covers:

https://wolfram.com/xid/0e7p5nb2-vg4vnl

Return the minimal vertex covers of the tetrahedral graph:

https://wolfram.com/xid/0e7p5nb2-slyqjh

Return the number of minimum clique coverings for the cubical graph:

https://wolfram.com/xid/0e7p5nb2-kerpnj

Compare to the length of the list:

https://wolfram.com/xid/0e7p5nb2-ole4s1

Give the number of minimum path coverings of the 4-star graph:

https://wolfram.com/xid/0e7p5nb2-1lo3v8

Return using a "Count" qualifier:

https://wolfram.com/xid/0e7p5nb2-2hdg1n

Compare with minimum path coverings:

https://wolfram.com/xid/0e7p5nb2-2wrcyx


https://wolfram.com/xid/0e7p5nb2-ja7ds8

Show the minimum path coverings of the 4-star graph:

https://wolfram.com/xid/0e7p5nb2-r0zumf


https://wolfram.com/xid/0e7p5nb2-60tr7w

Give the path covering number of the cross graph:

https://wolfram.com/xid/0e7p5nb2-8xxw5g


https://wolfram.com/xid/0e7p5nb2-hk9nsb

Append "paths" of length 0 to the paths on the graph:

https://wolfram.com/xid/0e7p5nb2-5livlk


https://wolfram.com/xid/0e7p5nb2-1r3gzk

The path covering number is the smallest number of vertex-disjoint paths that cover the given graph:

https://wolfram.com/xid/0e7p5nb2-2xqy81

Compare with the minimum path coverings:

https://wolfram.com/xid/0e7p5nb2-w6z0tl

Give the number of vertex covers of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-sow338

Compare to the length of the list of edge covers:

https://wolfram.com/xid/0e7p5nb2-v0zp3c

Return the vertex cover number:

https://wolfram.com/xid/0e7p5nb2-jbjjyu

Compare with the size of a minimum vertex cover:

https://wolfram.com/xid/0e7p5nb2-oqq0d7


https://wolfram.com/xid/0e7p5nb2-s7yzng

Give the vertex cover polynomial of the utility graph:

https://wolfram.com/xid/0e7p5nb2-y58vrs

Compare to the explicit covers:

https://wolfram.com/xid/0e7p5nb2-cmdes9


https://wolfram.com/xid/0e7p5nb2-mkug58

Give the vertex covers of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-rhw8ye

Independent Set‐Related Graph Properties (27)
Give the biclique cover of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-5q6rbt

Give the bipartite dimension of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-u3dgm9

Return the fractional independence number of the Petersen graph:

https://wolfram.com/xid/0e7p5nb2-3rhpso

Compare with the usual independence number:

https://wolfram.com/xid/0e7p5nb2-5yug29

Return the independence number of the Heawood graph:

https://wolfram.com/xid/0e7p5nb2-dbxbbk

Compare with the size of a maximum independent vertex set:

https://wolfram.com/xid/0e7p5nb2-jm9un0


https://wolfram.com/xid/0e7p5nb2-r74urp

Return the independence polynomial of the utility graph:

https://wolfram.com/xid/0e7p5nb2-w9nkd6

Compare to the explicit independent sets:

https://wolfram.com/xid/0e7p5nb2-j8ymnc


https://wolfram.com/xid/0e7p5nb2-u6qelq

Return the independence ratio of the Petersen graph:

https://wolfram.com/xid/0e7p5nb2-m9u78m

Compare to the direct ratio of properties:

https://wolfram.com/xid/0e7p5nb2-45idot

Return the number of independent edge sets of the Heawood graph:

https://wolfram.com/xid/0e7p5nb2-nhngjk

Compare to the explicit independent sets:

https://wolfram.com/xid/0e7p5nb2-ee6ksa

Return the independent edge sets of the utility graph:

https://wolfram.com/xid/0e7p5nb2-9oxht2

Return the number of independent vertex sets of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-6fl7k5

Compare to the explicit independent sets:

https://wolfram.com/xid/0e7p5nb2-06fnbn

Return the independent vertex sets of the Heawood graph:

https://wolfram.com/xid/0e7p5nb2-x7jk4x

Return the intersection number of the Heawood graph:

https://wolfram.com/xid/0e7p5nb2-1k5ps9

Give the lower independence number of the Petersen graph:

https://wolfram.com/xid/0e7p5nb2-y79ck4

Compare with the smallest exponent of the maximal independence polynomial:

https://wolfram.com/xid/0e7p5nb2-ebre87


https://wolfram.com/xid/0e7p5nb2-ceekk8

Give the lower matching number of the Coxeter graph:

https://wolfram.com/xid/0e7p5nb2-iptg4c

Compare with the smallest exponent of the maximal matching-generating polynomial:

https://wolfram.com/xid/0e7p5nb2-desagz


https://wolfram.com/xid/0e7p5nb2-icsnuq

Return the matching-generating polynomial of the utility graph:

https://wolfram.com/xid/0e7p5nb2-2r7nec

Compare to the explicit independent edge sets:

https://wolfram.com/xid/0e7p5nb2-eakoig


https://wolfram.com/xid/0e7p5nb2-fr362r

Return the matching number of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-t0v2j2

Compare with the matching-generating polynomial:

https://wolfram.com/xid/0e7p5nb2-o46evj


https://wolfram.com/xid/0e7p5nb2-jvh9hq

Return the maximal independence polynomial for the Heawood graph:

https://wolfram.com/xid/0e7p5nb2-vatz1c

Compare with the numbers of maximal independent vertex sets:

https://wolfram.com/xid/0e7p5nb2-4mm9xi

Return the number of maximal independent edge sets for the cubical graph:

https://wolfram.com/xid/0e7p5nb2-g0j7xx

Compare with the number of maximal independent edge sets:

https://wolfram.com/xid/0e7p5nb2-mknlfs

Return the maximal independent edge sets for the cubical graph:

https://wolfram.com/xid/0e7p5nb2-tmtajw

Return the maximal matching-generating polynomial for the Heawood graph:

https://wolfram.com/xid/0e7p5nb2-d607ij

Compare with the explicit edge sets:

https://wolfram.com/xid/0e7p5nb2-cekji6

Return the number of maximal independent vertex sets for the Heawood graph:

https://wolfram.com/xid/0e7p5nb2-mav14e

Compare with the number of maximal independent vertex sets:

https://wolfram.com/xid/0e7p5nb2-rhtllx


https://wolfram.com/xid/0e7p5nb2-4bancl

Return the maximal independent vertex sets for the cubical graph:

https://wolfram.com/xid/0e7p5nb2-z7tfqv

Return the maximal independence polynomial for the cubical graph:

https://wolfram.com/xid/0e7p5nb2-7uscrn

Compare with the explicit edge sets:

https://wolfram.com/xid/0e7p5nb2-oohtxn

Return the maximal matching generating polynomial for the cubical graph:

https://wolfram.com/xid/0e7p5nb2-tc8vrx

Compare with the numbers of maximal independent edge sets:

https://wolfram.com/xid/0e7p5nb2-jdblie

Return the number of maximum independent edge sets for the Heawood graph:

https://wolfram.com/xid/0e7p5nb2-qgduic

Do the same with the "Count" annotation:

https://wolfram.com/xid/0e7p5nb2-g2aa8o

Return the maximum independent edge sets for the Heawood graph:

https://wolfram.com/xid/0e7p5nb2-cgb7a7

Return the number of maximum independent vertex sets for the Heawood graph:

https://wolfram.com/xid/0e7p5nb2-83y22q

Do the same with the "Count" annotation:

https://wolfram.com/xid/0e7p5nb2-dlcob2

Return the maximum independent vertex sets for the Heawood graph:

https://wolfram.com/xid/0e7p5nb2-t6tar6


https://wolfram.com/xid/0e7p5nb2-kx3j9b

Irredundant Set‐Related Graph Properties (9)
Give the irredundance number of the Petersen graph:

https://wolfram.com/xid/0e7p5nb2-4ow1l8

Compare with the smallest exponent of the maximal irredundance polynomial:

https://wolfram.com/xid/0e7p5nb2-s2ppz9


https://wolfram.com/xid/0e7p5nb2-wcog4a

Give the number of irredundant sets in the cubical graph:

https://wolfram.com/xid/0e7p5nb2-svbav6

Compare with the length of the list of sets:

https://wolfram.com/xid/0e7p5nb2-crxob4


https://wolfram.com/xid/0e7p5nb2-hk6r4f

Give the irredundant sets in the cubical graph:

https://wolfram.com/xid/0e7p5nb2-ydq6xb

Give the maximal irredundant polynomial of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-fkkuaz

Compute from the maximal irredundant sets:

https://wolfram.com/xid/0e7p5nb2-kmi8r0

Give the number of maximal irredundant sets in the cubical graph:

https://wolfram.com/xid/0e7p5nb2-wuyk42

Compare with the length of the list of sets:

https://wolfram.com/xid/0e7p5nb2-616vzs


https://wolfram.com/xid/0e7p5nb2-7yru9i

Give the maximal irredundant sets in the cubical graph:

https://wolfram.com/xid/0e7p5nb2-cbxre0

Give the number of maximum irredundant sets in the cubical graph:

https://wolfram.com/xid/0e7p5nb2-gqxz6l

Compare with the length of the list of sets:

https://wolfram.com/xid/0e7p5nb2-od4uc7


https://wolfram.com/xid/0e7p5nb2-if1et3

Give the maximum irredundant sets in the cubical graph:

https://wolfram.com/xid/0e7p5nb2-h0wn4w

Give the upper irredundance number of the Petersen graph:

https://wolfram.com/xid/0e7p5nb2-lq77rj

Compare with the largest exponent of the maximal irredundance polynomial:

https://wolfram.com/xid/0e7p5nb2-gv9kp3


https://wolfram.com/xid/0e7p5nb2-jfaas1

Dominating Set‐Related Graph Properties (29)
Return the connected dominating set count of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-pj0tzi

Compare with the connected domination polynomial:

https://wolfram.com/xid/0e7p5nb2-de4m1l

Compare with the connected dominating sets:

https://wolfram.com/xid/0e7p5nb2-ybgq63

Give the connected dominating sets of the square graph:

https://wolfram.com/xid/0e7p5nb2-ykztc5


https://wolfram.com/xid/0e7p5nb2-kirlqx

Return the connected domination number of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-nfmo6y

Compare with the connected domination polynomial:

https://wolfram.com/xid/0e7p5nb2-fa419m

Compare with the connected dominating sets:

https://wolfram.com/xid/0e7p5nb2-7kh2a8

Return the connected domination polynomial of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-yjkn5e

Compare with the sizes of connected dominating sets:

https://wolfram.com/xid/0e7p5nb2-88p2wg

Give the domatic numbers of the first several hypercube graphs:

https://wolfram.com/xid/0e7p5nb2-5c2nei

Return the number of dominating sets of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-ua0iwa

Compare with the domination polynomial:

https://wolfram.com/xid/0e7p5nb2-sanf52

Compare with the dominating sets:

https://wolfram.com/xid/0e7p5nb2-82hiby

Return the dominating sets of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-xluehx

Return the domination number of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-jqd4cf

Return the domination polynomial of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-ffuegq

Compare with the sizes of dominating sets:

https://wolfram.com/xid/0e7p5nb2-ofpnnx

Give the number of minimal connected dominating sets in the Nauru graph:

https://wolfram.com/xid/0e7p5nb2-wqe21c

Compute from the minimal connected dominating sets:

https://wolfram.com/xid/0e7p5nb2-ng343n


https://wolfram.com/xid/0e7p5nb2-vvyzrj

Return the minimal connected dominating sets in the Nauru graph:

https://wolfram.com/xid/0e7p5nb2-bvtcd4

Give the minimal connected domination polynomial of the Nauru graph:

https://wolfram.com/xid/0e7p5nb2-b3pfil

Compute from the minimal connected dominating sets:

https://wolfram.com/xid/0e7p5nb2-ba3c04

Give the number of minimal dominating sets in the cubical graph:

https://wolfram.com/xid/0e7p5nb2-ngbugd

Compute from the minimal dominating sets:

https://wolfram.com/xid/0e7p5nb2-hfusdf


https://wolfram.com/xid/0e7p5nb2-lhnv92

Return the minimal dominating sets in the cubical graph:

https://wolfram.com/xid/0e7p5nb2-2sp5hb

Give the minimal domination polynomial of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-b791vr

Compute from the minimal dominating sets:

https://wolfram.com/xid/0e7p5nb2-60hmq8

Give the minimal total dominating set count of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-ldibsj

Compute from the minimal total dominating sets:

https://wolfram.com/xid/0e7p5nb2-wcjwx7


https://wolfram.com/xid/0e7p5nb2-pppwdl

Give the minimal total dominating sets in the cubical graph:

https://wolfram.com/xid/0e7p5nb2-datwjz

Give the minimal total domination polynomial of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-nsz9vb

Compute from the minimal total dominating sets:

https://wolfram.com/xid/0e7p5nb2-ybcz4q

Return the minimum connected dominating set count of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-we3vt6

Compare with the connected domination polynomial:

https://wolfram.com/xid/0e7p5nb2-8j6nwt

Compare with the minimum connected dominating sets:

https://wolfram.com/xid/0e7p5nb2-02k89v

Give the minimum connected dominating sets of the square graph:

https://wolfram.com/xid/0e7p5nb2-k8tzb0

Return the number of minimum dominating sets for the cubical graph:

https://wolfram.com/xid/0e7p5nb2-dcj297

Do the same using the "Count" annotation:

https://wolfram.com/xid/0e7p5nb2-oj89ro

Compare to the value computed from the domination polynomial:

https://wolfram.com/xid/0e7p5nb2-mmv3kc

Return the minimum dominating sets for the cubical graph:

https://wolfram.com/xid/0e7p5nb2-oflhbz


https://wolfram.com/xid/0e7p5nb2-2nujew

Compare to the number from the direct property:

https://wolfram.com/xid/0e7p5nb2-bhqokg

Return the number of minimum total dominating sets for the cubical graph:

https://wolfram.com/xid/0e7p5nb2-fkm193

Do the same using the "Count" annotation:

https://wolfram.com/xid/0e7p5nb2-jio3ph

Compare to the value computed from the total domination polynomial:

https://wolfram.com/xid/0e7p5nb2-g0kjtg

Return the minimum total dominating sets for the cubical graph:

https://wolfram.com/xid/0e7p5nb2-f4rb08


https://wolfram.com/xid/0e7p5nb2-8vnjdf

Compare to the number from the direct property:

https://wolfram.com/xid/0e7p5nb2-xpet5l

Return the number of total dominating sets of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-59izsc

Compare with the total domination polynomial:

https://wolfram.com/xid/0e7p5nb2-5ww6t2

Compare with the total dominating sets:

https://wolfram.com/xid/0e7p5nb2-w2bn4j

Return the total dominating sets of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-uludfb

Return the total domination number of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-7tregq

Return the total domination polynomial of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-9mtwql

Compare with the sizes of total dominating sets:

https://wolfram.com/xid/0e7p5nb2-yl7iho

Return the upper domination number of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-rmaacj

Compare with the largest exponent of the minimal domination polynomial:

https://wolfram.com/xid/0e7p5nb2-pz8dfo


https://wolfram.com/xid/0e7p5nb2-gq30ho

Symmetry‐Related Graph Properties (18)
Display the arc transitivity of the Coxeter graph:

https://wolfram.com/xid/0e7p5nb2-6v4jfg


https://wolfram.com/xid/0e7p5nb2-lj8txm

Produce a table of the arc transitivities of some small arc-transitive graphs:

https://wolfram.com/xid/0e7p5nb2-ywzj7k

Give the order of the automorphism group of the octahedral graph:

https://wolfram.com/xid/0e7p5nb2-ouaa3r

Directly compute from the group:

https://wolfram.com/xid/0e7p5nb2-9ppoqe


https://wolfram.com/xid/0e7p5nb2-qlsgyi

Give the number of distinct edge lengths in the 4-trapezohedron:

https://wolfram.com/xid/0e7p5nb2-mj3fia

Show the corresponding polyhedron:

https://wolfram.com/xid/0e7p5nb2-9stv2m

List the names of groups generating the cubical graph as an (undirected) Cayley graph:

https://wolfram.com/xid/0e7p5nb2-or28q4

Visualize the (directed) Cayley graphs:

https://wolfram.com/xid/0e7p5nb2-xhtya5

Verify the undirected graphs are isomorphic with the cubical graph:

https://wolfram.com/xid/0e7p5nb2-l3o92h

List group representations (not necessarily corresponding to distinct groups) that generate the cubical graph as an (undirected) Cayley graph:

https://wolfram.com/xid/0e7p5nb2-ehuf60


https://wolfram.com/xid/0e7p5nb2-41wkku

Verify these all generate the cubical graph:

https://wolfram.com/xid/0e7p5nb2-7v2sua

Give the distinguishing number of the Petersen graph:

https://wolfram.com/xid/0e7p5nb2-4fj6jg

Give the fixing number of the Petersen graph:

https://wolfram.com/xid/0e7p5nb2-ijg2no

Give the number of minimum distinguishing labelings of the Petersen graph:

https://wolfram.com/xid/0e7p5nb2-nm53dz

Do the same using the "Count" annotation:

https://wolfram.com/xid/0e7p5nb2-qh7pvn

Give minimum distinguishing labelings of the Petersen graph:

https://wolfram.com/xid/0e7p5nb2-wdnw5i


https://wolfram.com/xid/0e7p5nb2-du6md3

Compare with the value from the direct property:

https://wolfram.com/xid/0e7p5nb2-7n72dy

Give the number of planar embeddings in the Eiffel Tower graph:

https://wolfram.com/xid/0e7p5nb2-4csh5r

Give the number of planar embeddings of a nonplanar graph:

https://wolfram.com/xid/0e7p5nb2-uu9dte

Give the number of planar embeddings of a uniquely embeddable graph:

https://wolfram.com/xid/0e7p5nb2-2ns54u

Give the number of symmetrically distinct faces in the truncated cubical graph:

https://wolfram.com/xid/0e7p5nb2-r8k43t

Give representatives of the symmetrically distinct faces in the truncated cubical graph:

https://wolfram.com/xid/0e7p5nb2-lkew76


https://wolfram.com/xid/0e7p5nb2-32etdd

Give the number of symmetrically distinct vertices in the butterfly graph:

https://wolfram.com/xid/0e7p5nb2-8lrexc

Give representatives of symmetrically distinct vertices:

https://wolfram.com/xid/0e7p5nb2-bv1cgf


https://wolfram.com/xid/0e7p5nb2-4qi2ol

Give the number of symmetrically distinct vertex pairs in the Petersen graph:

https://wolfram.com/xid/0e7p5nb2-8t07rw

Compare with the signature of symmetrically distinct vertex pairs:

https://wolfram.com/xid/0e7p5nb2-spibpz


https://wolfram.com/xid/0e7p5nb2-w0rzwm

Give the signature of symmetrically distinct vertex pairs in the Petersen graph:

https://wolfram.com/xid/0e7p5nb2-nxru9m

This means that there are 30 vertex pairs symmetrically equivalent to and 15 equivalent to
:

https://wolfram.com/xid/0e7p5nb2-o3m1ok

Compare the number of symmetrically distinct vertex pairs with the count:

https://wolfram.com/xid/0e7p5nb2-9sdfa5


https://wolfram.com/xid/0e7p5nb2-4qsa1l

Give representatives of symmetrically distinct vertices in the butterfly graph:

https://wolfram.com/xid/0e7p5nb2-5944w2


https://wolfram.com/xid/0e7p5nb2-fjjptr

List all symmetrically equivalent faces in the truncated tetrahedral graph:

https://wolfram.com/xid/0e7p5nb2-sthuya

Visualize via the graph's polyhedral embedding:

https://wolfram.com/xid/0e7p5nb2-mhxn45

List the symmetrically equivalent vertices in the butterfly graph:

https://wolfram.com/xid/0e7p5nb2-3clr3l


https://wolfram.com/xid/0e7p5nb2-s6av2f

Information‐Related Graph Properties (12)
Give the bandwidth of the 5-hypercube graph:

https://wolfram.com/xid/0e7p5nb2-62ceqe

Compare to the known closed form:

https://wolfram.com/xid/0e7p5nb2-okdbme

Give the burning number of the 5-star graph:

https://wolfram.com/xid/0e7p5nb2-i6kb2f

Give the cooling number of the 5-cycle graph:

https://wolfram.com/xid/0e7p5nb2-gl18kv

The cooling number of the -cycle is given by
:

https://wolfram.com/xid/0e7p5nb2-cho6qr

Give the gonality of the 5-star graph:

https://wolfram.com/xid/0e7p5nb2-d9amc5

Return the likelihood of the Petersen graph:

https://wolfram.com/xid/0e7p5nb2-bx3ozp

Likelihoods are normalized for fixed node count:

https://wolfram.com/xid/0e7p5nb2-5thc5r

Return the Lovász number of the 5-cycle graph:

https://wolfram.com/xid/0e7p5nb2-pbj49w

Give the pathwidths of the hypercube graphs:

https://wolfram.com/xid/0e7p5nb2-7umulg

Compare to the known closed form:

https://wolfram.com/xid/0e7p5nb2-ifzdf0

Give the pebbling number of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-kw5kkx

Give the scramble number of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-q1pr6f

Display the Shannon capacity of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-f45nz

Give the tree depth of a complete graph:

https://wolfram.com/xid/0e7p5nb2-0r38b9

Give the treewidth of a complete graph:

https://wolfram.com/xid/0e7p5nb2-gm7r1y

Give the treewidth of a complete bipartite graph:

https://wolfram.com/xid/0e7p5nb2-ptbt2w

Path‐ and Cycle‐Related Properties (45)
Return the number of chordless cycles in the Petersen graph:

https://wolfram.com/xid/0e7p5nb2-sbwrct

Verify against the chordless cycle polynomial:

https://wolfram.com/xid/0e7p5nb2-7510k4

Verify against the chordless cycles:

https://wolfram.com/xid/0e7p5nb2-6pyx0x


https://wolfram.com/xid/0e7p5nb2-287y5b

Return the chordless cycle polynomial of the Petersen graph:

https://wolfram.com/xid/0e7p5nb2-r5uzfm

Give the chordless cycles of the Petersen graph:

https://wolfram.com/xid/0e7p5nb2-iqeziz


https://wolfram.com/xid/0e7p5nb2-sdxe17

Visually verify the returned cycles are chordless:

https://wolfram.com/xid/0e7p5nb2-cqlu1i

Return the number of chordless cycles in the complement of the Petersen graph:

https://wolfram.com/xid/0e7p5nb2-otnva3

Verify against the chordless cycle polynomial:

https://wolfram.com/xid/0e7p5nb2-3a5803

Verify against the chordless cycles:

https://wolfram.com/xid/0e7p5nb2-5o1ja5


https://wolfram.com/xid/0e7p5nb2-hb5u0r

Return the chordless cycle polynomial in the complement of the Petersen graph:

https://wolfram.com/xid/0e7p5nb2-2lpoeo

Compare with the property computed from the complement:

https://wolfram.com/xid/0e7p5nb2-0v87wt

Return the chordless cycles of the complement of the Petersen graph:

https://wolfram.com/xid/0e7p5nb2-0dff9p

Return the number of chordless cycles in the complement of the Petersen graph:

https://wolfram.com/xid/0e7p5nb2-c97mh

Verify against the chordless cycle polynomial:

https://wolfram.com/xid/0e7p5nb2-kc3ww3

Verify against the chordless cycles:

https://wolfram.com/xid/0e7p5nb2-zqa802


https://wolfram.com/xid/0e7p5nb2-x7ffhg

Return the odd chordless cycle polynomial in the complement of the Petersen graph:

https://wolfram.com/xid/0e7p5nb2-87lk3x

Compare with the property computed from the complement:

https://wolfram.com/xid/0e7p5nb2-7f6ciz

Return the odd chordless cycles of the complement of the Petersen graph:

https://wolfram.com/xid/0e7p5nb2-h8fy5m

Give the name of the cube graph of the 7-Möbius ladder:

https://wolfram.com/xid/0e7p5nb2-qnsvx4


https://wolfram.com/xid/0e7p5nb2-zao4q7

Compare with the third graph power:

https://wolfram.com/xid/0e7p5nb2-51359o

Verify the graph property and computed graphs are isomorphic:

https://wolfram.com/xid/0e7p5nb2-4y2ti6

Return the number of cycles of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-ukkws0

Do the same using the "Count" annotation:

https://wolfram.com/xid/0e7p5nb2-jeobhw


https://wolfram.com/xid/0e7p5nb2-geczto


https://wolfram.com/xid/0e7p5nb2-v3vxdp

Give the cycle polynomial of the cubical graph as a pure function:

https://wolfram.com/xid/0e7p5nb2-kfyn1w


https://wolfram.com/xid/0e7p5nb2-8ixf7j


https://wolfram.com/xid/0e7p5nb2-qowlyg

Return the cycles in the cubical graph:

https://wolfram.com/xid/0e7p5nb2-mm3ul6

Return the number of Eulerian cycles of the butterfly graph:

https://wolfram.com/xid/0e7p5nb2-0b9w0g


https://wolfram.com/xid/0e7p5nb2-qp1xm


https://wolfram.com/xid/0e7p5nb2-44ey6a


https://wolfram.com/xid/0e7p5nb2-iy9ss6

Visualize the Eulerian cycles:

https://wolfram.com/xid/0e7p5nb2-lmrwda

Give the tally of cubical graph face sizes:

https://wolfram.com/xid/0e7p5nb2-i63200


https://wolfram.com/xid/0e7p5nb2-mmdwlz


https://wolfram.com/xid/0e7p5nb2-0lzniz

Display the girth of the Petersen graph:

https://wolfram.com/xid/0e7p5nb2-mnxfjb

Return the number of Hamilton decompositions of the octahedral graph:

https://wolfram.com/xid/0e7p5nb2-gmemrt

Do the same using the "Count" annotation:

https://wolfram.com/xid/0e7p5nb2-vj0ykq

Return Hamilton decompositions of the octahedral graph:

https://wolfram.com/xid/0e7p5nb2-3a32ji


https://wolfram.com/xid/0e7p5nb2-7ln3wy

Return the number of Hamiltonian cycles of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-r8f4hf

Do the same using the "Count" annotation:

https://wolfram.com/xid/0e7p5nb2-f948tx

List the Hamiltonian cycles of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-c91vwk


https://wolfram.com/xid/0e7p5nb2-bzgrvm

Display the Hamiltonian cycles:

https://wolfram.com/xid/0e7p5nb2-mns03w

Return the Hamiltonian number of the octahedral graph:

https://wolfram.com/xid/0e7p5nb2-pe0oaj

Return the number of Hamiltonian paths of the tetrahedral graph:

https://wolfram.com/xid/0e7p5nb2-f6azsk

Do the same using the "Count" annotation:

https://wolfram.com/xid/0e7p5nb2-mr89bg

Return the Hamiltonian paths of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-i8garp


https://wolfram.com/xid/0e7p5nb2-erboov

Display the Hamiltonian paths:

https://wolfram.com/xid/0e7p5nb2-o247z1

Return the number of Hamiltonian walks of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-ic1vox

Do the same using the "Count" annotation:

https://wolfram.com/xid/0e7p5nb2-uu033

List the Hamiltonian walks of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-ohpwso

Give the hexagon count of the truncated tetrahedral graph:

https://wolfram.com/xid/0e7p5nb2-4w4if

Compare with the value from the cycle polynomial:

https://wolfram.com/xid/0e7p5nb2-rkpzox

Return the k-cyclic indices of the butterfly graph:

https://wolfram.com/xid/0e7p5nb2-18pma7

Give the longest cycle count of the (3,4)-cone graph:

https://wolfram.com/xid/0e7p5nb2-q9rdyx

Do the same using the "Count" annotation:

https://wolfram.com/xid/0e7p5nb2-glog5h

Give the longest cycles of the (3,4)-cone graph:

https://wolfram.com/xid/0e7p5nb2-3phb2


https://wolfram.com/xid/0e7p5nb2-3ycs1o

Compare to the value from the direct property:

https://wolfram.com/xid/0e7p5nb2-0dcl4t

Compare to the number of hexagons:

https://wolfram.com/xid/0e7p5nb2-3m5znn

Give the longest path count of the (3,4)-cone graph:

https://wolfram.com/xid/0e7p5nb2-7dv9na

Do the same using the "Count" annotation:

https://wolfram.com/xid/0e7p5nb2-muvomr

Give the longest path length of the (3,4)-cone graph:

https://wolfram.com/xid/0e7p5nb2-uouqgo

Compare to the value obtained from the paths themselves (adjusting for the fact that a path specified by vertices has length
):

https://wolfram.com/xid/0e7p5nb2-q0bv9b

Give the longest paths of the (3,4)-cone graph:

https://wolfram.com/xid/0e7p5nb2-jowuuf


https://wolfram.com/xid/0e7p5nb2-rjk7cv

Compare to the value from the direct property:

https://wolfram.com/xid/0e7p5nb2-dii5zc

Give the number of minimum path coverings of the 5-wheel graph:

https://wolfram.com/xid/0e7p5nb2-prtqoo

Give the minimum path coverings of the 5-wheel graph:

https://wolfram.com/xid/0e7p5nb2-koju26

View some of the edge coverings:

https://wolfram.com/xid/0e7p5nb2-ku7oxb

Since this graph is traceable, the minimum path coverings correspond to Hamiltonian paths:

https://wolfram.com/xid/0e7p5nb2-w9bd2c

Return the number of odd chordless cycles in the Petersen graph:

https://wolfram.com/xid/0e7p5nb2-bmwens

Verify against the chordless cycle polynomial:

https://wolfram.com/xid/0e7p5nb2-wl6p5f


https://wolfram.com/xid/0e7p5nb2-g1s0da

Verify against the chordless cycles:

https://wolfram.com/xid/0e7p5nb2-udpc4p


https://wolfram.com/xid/0e7p5nb2-j3svrl

Give the odd chordless cycle polynomial of the 9-antiprism graph:

https://wolfram.com/xid/0e7p5nb2-17kunn

Compare with the length tallies of all odd chordless cycles:

https://wolfram.com/xid/0e7p5nb2-2bw2yl

Give the odd chordless cycles of the Petersen graph:

https://wolfram.com/xid/0e7p5nb2-th381u

Compare with the set of cycles extracted from all chordless cycles:

https://wolfram.com/xid/0e7p5nb2-1zkpbl

Return the number of paths of the butterfly graph:

https://wolfram.com/xid/0e7p5nb2-1vgr02

Do the same using the "Count" annotation:

https://wolfram.com/xid/0e7p5nb2-mt8n1o


https://wolfram.com/xid/0e7p5nb2-81xdnk


https://wolfram.com/xid/0e7p5nb2-4jhd13

Give the path polynomial of the butterfly graph as a pure function:

https://wolfram.com/xid/0e7p5nb2-t7wy47

Compare to path length tallies:

https://wolfram.com/xid/0e7p5nb2-o62iwn


https://wolfram.com/xid/0e7p5nb2-jlq3gr

Give the path covering number of the cross graph:

https://wolfram.com/xid/0e7p5nb2-p21lpb

Exhibit a path covering consisting of two paths:

https://wolfram.com/xid/0e7p5nb2-bjw44g


https://wolfram.com/xid/0e7p5nb2-4c48fs


https://wolfram.com/xid/0e7p5nb2-mccadm


https://wolfram.com/xid/0e7p5nb2-rrrnl3


https://wolfram.com/xid/0e7p5nb2-cyb68q

Return the paths in the butterfly graph:

https://wolfram.com/xid/0e7p5nb2-yrffgi

Give the pentagon count of the snub cubical graph:

https://wolfram.com/xid/0e7p5nb2-721mxj

Compare with the value from the cycle polynomial:

https://wolfram.com/xid/0e7p5nb2-7p0sia

Give the square count of the snub cubical graph:

https://wolfram.com/xid/0e7p5nb2-gudc96

Compare with the value from the cycle polynomial:

https://wolfram.com/xid/0e7p5nb2-r6nbzr

Graphs with nonzero square count should not be square-free:

https://wolfram.com/xid/0e7p5nb2-3y3aji

Give the name of the square graph of the 7-Möbius ladder:

https://wolfram.com/xid/0e7p5nb2-nmbrdf


https://wolfram.com/xid/0e7p5nb2-bx65yw

Compare with the second graph power:

https://wolfram.com/xid/0e7p5nb2-6j46gr

Verify the graph property and computed graphs are isomorphic:

https://wolfram.com/xid/0e7p5nb2-6fcjf

Give the square count of the snub cubical graph:

https://wolfram.com/xid/0e7p5nb2-osqbyv

Compare with the value from the cycle polynomial:

https://wolfram.com/xid/0e7p5nb2-dw4o9r

Graphs with nonzero triangle count should not be triangle-free:

https://wolfram.com/xid/0e7p5nb2-xv96zi

Graph Centralities (11)

https://wolfram.com/xid/0e7p5nb2-ouqya


https://wolfram.com/xid/0e7p5nb2-52in0o


https://wolfram.com/xid/0e7p5nb2-dg49lr


https://wolfram.com/xid/0e7p5nb2-3rojer


https://wolfram.com/xid/0e7p5nb2-k1ubki


https://wolfram.com/xid/0e7p5nb2-g2u26u


https://wolfram.com/xid/0e7p5nb2-qu13dl


https://wolfram.com/xid/0e7p5nb2-so7k59

Identical to reciprocal of vertex eccentricities for a connected graph:

https://wolfram.com/xid/0e7p5nb2-q5bvw8

Edge betweenness centralities:

https://wolfram.com/xid/0e7p5nb2-bntr0u


https://wolfram.com/xid/0e7p5nb2-t1thka


https://wolfram.com/xid/0e7p5nb2-ita86v


https://wolfram.com/xid/0e7p5nb2-jjtq8s


https://wolfram.com/xid/0e7p5nb2-xdg96i


https://wolfram.com/xid/0e7p5nb2-isaehk


https://wolfram.com/xid/0e7p5nb2-f4rv7l


https://wolfram.com/xid/0e7p5nb2-pdyfwz

Return using explicit variables:

https://wolfram.com/xid/0e7p5nb2-63rov4


https://wolfram.com/xid/0e7p5nb2-euvcmg


https://wolfram.com/xid/0e7p5nb2-2f0nsj


https://wolfram.com/xid/0e7p5nb2-8ghgv3


https://wolfram.com/xid/0e7p5nb2-7s7c5w

Graph Clustering Coefficients (3)
Give the global clustering coefficient of the house graph:

https://wolfram.com/xid/0e7p5nb2-phzkht

Compare with the value computed from the graph by the built-in function:

https://wolfram.com/xid/0e7p5nb2-qbk1h2

Give the local clustering coefficients of the house graph:

https://wolfram.com/xid/0e7p5nb2-od8y6y

Compare with the value computed from the graph by the built-in function:

https://wolfram.com/xid/0e7p5nb2-5zw58a

Give the mean clustering coefficient of the house graph:

https://wolfram.com/xid/0e7p5nb2-809e8r

Compare with the value computed from the graph by the built-in function:

https://wolfram.com/xid/0e7p5nb2-6vw6fk

Naming‐Related Properties (7)
List the alternate English names of the tesseract graph:

https://wolfram.com/xid/0e7p5nb2-fmb2n2

Show the alternate standard names for the tesseract graph:

https://wolfram.com/xid/0e7p5nb2-l6pa98

Give the entity for the Petersen graph:

https://wolfram.com/xid/0e7p5nb2-61yrpj

Give the textual name of the octahedral graph:

https://wolfram.com/xid/0e7p5nb2-g75tv

Give the name of the complete graph :

https://wolfram.com/xid/0e7p5nb2-ghg3ls

Verify the standard name for this graph:

https://wolfram.com/xid/0e7p5nb2-gnmaou


https://wolfram.com/xid/0e7p5nb2-ha7r5e

Give all textual names of the octahedral graph:

https://wolfram.com/xid/0e7p5nb2-69q6m2

Query the standard name of the 4-hypercube graph:

https://wolfram.com/xid/0e7p5nb2-mc3ilh

Show other alternate standard names corresponding to this standard name:

https://wolfram.com/xid/0e7p5nb2-bc9coy


https://wolfram.com/xid/0e7p5nb2-9kb9zz

Give the standard name of the complete graph :

https://wolfram.com/xid/0e7p5nb2-ubvshh


https://wolfram.com/xid/0e7p5nb2-17helo

Give all standard names of the octahedral graph:

https://wolfram.com/xid/0e7p5nb2-kcj451

Notation‐Related Properties (3)
Give LCF notations for the octahedral graph (sorted by exponents):

https://wolfram.com/xid/0e7p5nb2-qn8bim


https://wolfram.com/xid/0e7p5nb2-ju4dhp

Tally the LCF notation exponents:

https://wolfram.com/xid/0e7p5nb2-pn2mnf

Display the nontrivial LCF embeddings:

https://wolfram.com/xid/0e7p5nb2-baubqz

Give the primary notation of the cubical graph:

https://wolfram.com/xid/0e7p5nb2-3snl8k

Display the notation with traditional typesetting:

https://wolfram.com/xid/0e7p5nb2-2s3t5s

Give a list of rules for notations associated with the complete graph :

https://wolfram.com/xid/0e7p5nb2-ztexke

Give rules for various notations for the octahedral graph:

https://wolfram.com/xid/0e7p5nb2-bps542

Basic Classes (4)

https://wolfram.com/xid/0e7p5nb2-uvkt6k


https://wolfram.com/xid/0e7p5nb2-w44vzu


https://wolfram.com/xid/0e7p5nb2-zcw2d8


https://wolfram.com/xid/0e7p5nb2-x1i2wd


https://wolfram.com/xid/0e7p5nb2-ppn93z


https://wolfram.com/xid/0e7p5nb2-im2sut


https://wolfram.com/xid/0e7p5nb2-k2bqqm


https://wolfram.com/xid/0e7p5nb2-ykq2y9


https://wolfram.com/xid/0e7p5nb2-qfrw2h


https://wolfram.com/xid/0e7p5nb2-jrecoa


https://wolfram.com/xid/0e7p5nb2-6zfq7j


https://wolfram.com/xid/0e7p5nb2-bv5qx7


https://wolfram.com/xid/0e7p5nb2-g9gxjj

Classes Based on Crossings (11)

https://wolfram.com/xid/0e7p5nb2-6uvkdw


https://wolfram.com/xid/0e7p5nb2-t35vtk

List the doublecross graphs on 7 or fewer graphs:

https://wolfram.com/xid/0e7p5nb2-c4c5af

Compare with the crossing numbers:

https://wolfram.com/xid/0e7p5nb2-rf982v


https://wolfram.com/xid/0e7p5nb2-wnc7fn

List intrinsically linked graphs:

https://wolfram.com/xid/0e7p5nb2-qp3s6u

List linklessly embeddable graphs:

https://wolfram.com/xid/0e7p5nb2-85vmxc


https://wolfram.com/xid/0e7p5nb2-zbqqyq

List the planar graphs on 5 or fewer graphs:

https://wolfram.com/xid/0e7p5nb2-l1qo15


https://wolfram.com/xid/0e7p5nb2-uomem8

Compare with the crossing numbers:

https://wolfram.com/xid/0e7p5nb2-74qzw4


https://wolfram.com/xid/0e7p5nb2-wad4cm

List the singlecross graphs on 6 or fewer graphs:

https://wolfram.com/xid/0e7p5nb2-4m56se

Compare with the crossing numbers:

https://wolfram.com/xid/0e7p5nb2-fcxsiv


https://wolfram.com/xid/0e7p5nb2-yls3ds

Classes Based on Vertex Degrees (14)

https://wolfram.com/xid/0e7p5nb2-m6erp9


https://wolfram.com/xid/0e7p5nb2-c5i6uf


https://wolfram.com/xid/0e7p5nb2-e3659z


https://wolfram.com/xid/0e7p5nb2-84tsld


https://wolfram.com/xid/0e7p5nb2-ba7yry


https://wolfram.com/xid/0e7p5nb2-zmbwj0


https://wolfram.com/xid/0e7p5nb2-narci9


https://wolfram.com/xid/0e7p5nb2-469j0s


https://wolfram.com/xid/0e7p5nb2-qa6k3c


https://wolfram.com/xid/0e7p5nb2-vbqpdv


https://wolfram.com/xid/0e7p5nb2-rma12u


https://wolfram.com/xid/0e7p5nb2-wi4tho


https://wolfram.com/xid/0e7p5nb2-w32xpr


https://wolfram.com/xid/0e7p5nb2-63e67u


https://wolfram.com/xid/0e7p5nb2-67hvnx


https://wolfram.com/xid/0e7p5nb2-du5sb5


https://wolfram.com/xid/0e7p5nb2-11w89q


https://wolfram.com/xid/0e7p5nb2-383ikz


https://wolfram.com/xid/0e7p5nb2-zstvf0


https://wolfram.com/xid/0e7p5nb2-5i1uv


https://wolfram.com/xid/0e7p5nb2-sm55wn


https://wolfram.com/xid/0e7p5nb2-7tyoe3


https://wolfram.com/xid/0e7p5nb2-0ebqgf


https://wolfram.com/xid/0e7p5nb2-pfhx0d

Classes Based on Traversals (32)

https://wolfram.com/xid/0e7p5nb2-yvj6b


https://wolfram.com/xid/0e7p5nb2-7rd2no

Almost hypohamiltonian graphs:

https://wolfram.com/xid/0e7p5nb2-zulhmz


https://wolfram.com/xid/0e7p5nb2-knl7a0


https://wolfram.com/xid/0e7p5nb2-lajxm7


https://wolfram.com/xid/0e7p5nb2-cfb67o


https://wolfram.com/xid/0e7p5nb2-gsb0r8


https://wolfram.com/xid/0e7p5nb2-2l54gd


https://wolfram.com/xid/0e7p5nb2-coa2kn


https://wolfram.com/xid/0e7p5nb2-gwji83


https://wolfram.com/xid/0e7p5nb2-bz894n


https://wolfram.com/xid/0e7p5nb2-2gxtte


https://wolfram.com/xid/0e7p5nb2-2fupl


https://wolfram.com/xid/0e7p5nb2-qjlgta


https://wolfram.com/xid/0e7p5nb2-owqkx2


https://wolfram.com/xid/0e7p5nb2-myz9sd


https://wolfram.com/xid/0e7p5nb2-h6r8kd


https://wolfram.com/xid/0e7p5nb2-14vl2d


https://wolfram.com/xid/0e7p5nb2-lf592m

Graphs that provide counterexamples to Kempe's purported proof of the four-color theorem:

https://wolfram.com/xid/0e7p5nb2-ux9y3z


https://wolfram.com/xid/0e7p5nb2-5zzgr6

Maximally nonhamiltonian graphs:

https://wolfram.com/xid/0e7p5nb2-0it69v


https://wolfram.com/xid/0e7p5nb2-co7v8v


https://wolfram.com/xid/0e7p5nb2-j8tlx6


https://wolfram.com/xid/0e7p5nb2-fnc1xz


https://wolfram.com/xid/0e7p5nb2-ksor43


https://wolfram.com/xid/0e7p5nb2-xbso2


https://wolfram.com/xid/0e7p5nb2-so8x2c


https://wolfram.com/xid/0e7p5nb2-35ky44


https://wolfram.com/xid/0e7p5nb2-i8nd67


https://wolfram.com/xid/0e7p5nb2-54ydmw


https://wolfram.com/xid/0e7p5nb2-cl7e35

Pseudotrees that are not trees are equivalent to unicyclic graphs:

https://wolfram.com/xid/0e7p5nb2-rbmc7o


https://wolfram.com/xid/0e7p5nb2-jtpcs0


https://wolfram.com/xid/0e7p5nb2-zndu88


https://wolfram.com/xid/0e7p5nb2-f3dn6t


https://wolfram.com/xid/0e7p5nb2-emmr1i

Classes Based on Chess Boards (19)

https://wolfram.com/xid/0e7p5nb2-ik0myy


https://wolfram.com/xid/0e7p5nb2-k31q35


https://wolfram.com/xid/0e7p5nb2-pqi4an


https://wolfram.com/xid/0e7p5nb2-xd67yn


https://wolfram.com/xid/0e7p5nb2-eism8f


https://wolfram.com/xid/0e7p5nb2-wh6go


https://wolfram.com/xid/0e7p5nb2-v6dzj0


https://wolfram.com/xid/0e7p5nb2-6cgj45


https://wolfram.com/xid/0e7p5nb2-xsks2x


https://wolfram.com/xid/0e7p5nb2-hdxqj5


https://wolfram.com/xid/0e7p5nb2-b9j2bo

Triangular honeycomb acute knight graphs:

https://wolfram.com/xid/0e7p5nb2-3yhmls

Triangular honeycomb bishop graphs:

https://wolfram.com/xid/0e7p5nb2-yfftm

Triangular honeycomb king graphs:

https://wolfram.com/xid/0e7p5nb2-1g5pti

Triangular honeycomb obtuse knight graphs:

https://wolfram.com/xid/0e7p5nb2-6jrywc

Triangular honeycomb queen graphs:

https://wolfram.com/xid/0e7p5nb2-skqhs8

Triangular honeycomb rook graphs:

https://wolfram.com/xid/0e7p5nb2-u08oi5


https://wolfram.com/xid/0e7p5nb2-6r8lxx


https://wolfram.com/xid/0e7p5nb2-h3u40k

Classes Based on Symmetry and Regularity (21)

https://wolfram.com/xid/0e7p5nb2-uw00dt


https://wolfram.com/xid/0e7p5nb2-z1n2i8


https://wolfram.com/xid/0e7p5nb2-jbjmua


https://wolfram.com/xid/0e7p5nb2-sz6j6d


https://wolfram.com/xid/0e7p5nb2-mxn3oh


https://wolfram.com/xid/0e7p5nb2-t36i74


https://wolfram.com/xid/0e7p5nb2-bp85gd


https://wolfram.com/xid/0e7p5nb2-x4req1


https://wolfram.com/xid/0e7p5nb2-ycaaat


https://wolfram.com/xid/0e7p5nb2-099nq4


https://wolfram.com/xid/0e7p5nb2-py0w5m


https://wolfram.com/xid/0e7p5nb2-eh83m8


https://wolfram.com/xid/0e7p5nb2-7ov2rj


https://wolfram.com/xid/0e7p5nb2-ytzetc


https://wolfram.com/xid/0e7p5nb2-lhobrq


https://wolfram.com/xid/0e7p5nb2-rmqbaz


https://wolfram.com/xid/0e7p5nb2-y61bcx


https://wolfram.com/xid/0e7p5nb2-qumm9f


https://wolfram.com/xid/0e7p5nb2-hi26j6


https://wolfram.com/xid/0e7p5nb2-kjocp9


https://wolfram.com/xid/0e7p5nb2-4aq73p


https://wolfram.com/xid/0e7p5nb2-w2c6bh

Spectral Classes (3)

https://wolfram.com/xid/0e7p5nb2-wndcdi


https://wolfram.com/xid/0e7p5nb2-p4ixrk


https://wolfram.com/xid/0e7p5nb2-t51da8

Classes Based on Forbidden Graphs (10)

https://wolfram.com/xid/0e7p5nb2-j0gjct


https://wolfram.com/xid/0e7p5nb2-37y8io


https://wolfram.com/xid/0e7p5nb2-h128hs


https://wolfram.com/xid/0e7p5nb2-82nfbj


https://wolfram.com/xid/0e7p5nb2-mg7h0z


https://wolfram.com/xid/0e7p5nb2-13n5fs

Forbidden minors for pathwidth 1:

https://wolfram.com/xid/0e7p5nb2-j4vg85


https://wolfram.com/xid/0e7p5nb2-ps4nyk

Forbidden minors for pathwidth 2:

https://wolfram.com/xid/0e7p5nb2-ev3cjr


https://wolfram.com/xid/0e7p5nb2-h77cu7

Forbidden minors for linkless embeddabiity:

https://wolfram.com/xid/0e7p5nb2-ez9zdt


https://wolfram.com/xid/0e7p5nb2-md5i0

Projective planar forbidden minors:

https://wolfram.com/xid/0e7p5nb2-1njpbh


https://wolfram.com/xid/0e7p5nb2-8d9k33

Projective planar forbidden topological minors (homeomorphic subgraphs):

https://wolfram.com/xid/0e7p5nb2-spi2cg


https://wolfram.com/xid/0e7p5nb2-g9c53d


https://wolfram.com/xid/0e7p5nb2-7emksf


https://wolfram.com/xid/0e7p5nb2-p1lv3m

Unit-distance forbidden subgraphs:

https://wolfram.com/xid/0e7p5nb2-snhj64

Special Classes (50)

https://wolfram.com/xid/0e7p5nb2-otq4cq


https://wolfram.com/xid/0e7p5nb2-v6zuhi


https://wolfram.com/xid/0e7p5nb2-08wfnd


https://wolfram.com/xid/0e7p5nb2-lz0z31


https://wolfram.com/xid/0e7p5nb2-gw8gl1


https://wolfram.com/xid/0e7p5nb2-9p9up3


https://wolfram.com/xid/0e7p5nb2-3i0qqq


https://wolfram.com/xid/0e7p5nb2-fnb84l


https://wolfram.com/xid/0e7p5nb2-fgkst


https://wolfram.com/xid/0e7p5nb2-jiyz10

Chromatically unique graphs on six or fewer vertices:

https://wolfram.com/xid/0e7p5nb2-imp9lf

The cubical graph is chromatically unique:

https://wolfram.com/xid/0e7p5nb2-rfhj6m


https://wolfram.com/xid/0e7p5nb2-c4osrj

Find and show graphs that are cochromatic with the antenna graph:

https://wolfram.com/xid/0e7p5nb2-1awhyg


https://wolfram.com/xid/0e7p5nb2-xhwlbg


https://wolfram.com/xid/0e7p5nb2-pn61y9


https://wolfram.com/xid/0e7p5nb2-ccb4et


https://wolfram.com/xid/0e7p5nb2-eylu76

Graph represents a configuration:

https://wolfram.com/xid/0e7p5nb2-yifl52


https://wolfram.com/xid/0e7p5nb2-yothlo


https://wolfram.com/xid/0e7p5nb2-qfsqox


https://wolfram.com/xid/0e7p5nb2-9h7x24


https://wolfram.com/xid/0e7p5nb2-go3pr5


https://wolfram.com/xid/0e7p5nb2-98ivx


https://wolfram.com/xid/0e7p5nb2-wrhb71


https://wolfram.com/xid/0e7p5nb2-sq05xf


https://wolfram.com/xid/0e7p5nb2-n0ojf6


https://wolfram.com/xid/0e7p5nb2-4zgn7z


https://wolfram.com/xid/0e7p5nb2-1qcexm


https://wolfram.com/xid/0e7p5nb2-4nzpdi


https://wolfram.com/xid/0e7p5nb2-tg87sm

LCF (regular Hamiltonian) graphs:

https://wolfram.com/xid/0e7p5nb2-8lkfup


https://wolfram.com/xid/0e7p5nb2-tgaf9t


https://wolfram.com/xid/0e7p5nb2-41auk2


https://wolfram.com/xid/0e7p5nb2-hlvdgq


https://wolfram.com/xid/0e7p5nb2-5xwdr7


https://wolfram.com/xid/0e7p5nb2-d8lzja


https://wolfram.com/xid/0e7p5nb2-t7k3x6


https://wolfram.com/xid/0e7p5nb2-ryk8hw


https://wolfram.com/xid/0e7p5nb2-yzy6qu


https://wolfram.com/xid/0e7p5nb2-g5owk5


https://wolfram.com/xid/0e7p5nb2-9rj738


https://wolfram.com/xid/0e7p5nb2-qtwyte


https://wolfram.com/xid/0e7p5nb2-o9za21


https://wolfram.com/xid/0e7p5nb2-vwwsky


https://wolfram.com/xid/0e7p5nb2-lm1hl0

Quadratically embeddable graphs:

https://wolfram.com/xid/0e7p5nb2-1p5v2d


https://wolfram.com/xid/0e7p5nb2-n9ngc6


https://wolfram.com/xid/0e7p5nb2-jdwr2x


https://wolfram.com/xid/0e7p5nb2-uvzlfj


https://wolfram.com/xid/0e7p5nb2-jww7wl


https://wolfram.com/xid/0e7p5nb2-ljzx0a


https://wolfram.com/xid/0e7p5nb2-7hi509


https://wolfram.com/xid/0e7p5nb2-228ouv


https://wolfram.com/xid/0e7p5nb2-7olwxm


https://wolfram.com/xid/0e7p5nb2-29mo9r


https://wolfram.com/xid/0e7p5nb2-q6153x


https://wolfram.com/xid/0e7p5nb2-3prdjs


https://wolfram.com/xid/0e7p5nb2-wj01su

Classes Associated with Polyhedra (12)

https://wolfram.com/xid/0e7p5nb2-72e816


https://wolfram.com/xid/0e7p5nb2-w21vz7


https://wolfram.com/xid/0e7p5nb2-7rc604


https://wolfram.com/xid/0e7p5nb2-q89s6g


https://wolfram.com/xid/0e7p5nb2-zrj979


https://wolfram.com/xid/0e7p5nb2-2715l6


https://wolfram.com/xid/0e7p5nb2-j5sd8v


https://wolfram.com/xid/0e7p5nb2-khxxei


https://wolfram.com/xid/0e7p5nb2-cmwstn


https://wolfram.com/xid/0e7p5nb2-ujax7v


https://wolfram.com/xid/0e7p5nb2-9ny5qt


https://wolfram.com/xid/0e7p5nb2-5e5nk2


https://wolfram.com/xid/0e7p5nb2-lhnk8f


https://wolfram.com/xid/0e7p5nb2-7itbn0


https://wolfram.com/xid/0e7p5nb2-k13ba5


https://wolfram.com/xid/0e7p5nb2-17h9j4


https://wolfram.com/xid/0e7p5nb2-0rezkm

Uniform polyhedron skeleton graphs:

https://wolfram.com/xid/0e7p5nb2-p80gcq


https://wolfram.com/xid/0e7p5nb2-7u1had


https://wolfram.com/xid/0e7p5nb2-oqjjwm


https://wolfram.com/xid/0e7p5nb2-sh0l79

Snark-Related Classes (4)

https://wolfram.com/xid/0e7p5nb2-rm9wj7


https://wolfram.com/xid/0e7p5nb2-qdxd8j


https://wolfram.com/xid/0e7p5nb2-4114bt


https://wolfram.com/xid/0e7p5nb2-7ejons

Special Classes of Trees and Their Generalizations (12)

https://wolfram.com/xid/0e7p5nb2-bvid74


https://wolfram.com/xid/0e7p5nb2-ry7akw


https://wolfram.com/xid/0e7p5nb2-pxd1wc


https://wolfram.com/xid/0e7p5nb2-5285v9


https://wolfram.com/xid/0e7p5nb2-dcbh4b


https://wolfram.com/xid/0e7p5nb2-r325rz


https://wolfram.com/xid/0e7p5nb2-clm3lr


https://wolfram.com/xid/0e7p5nb2-tt0rpo


https://wolfram.com/xid/0e7p5nb2-m14arz


https://wolfram.com/xid/0e7p5nb2-ziwt2v


https://wolfram.com/xid/0e7p5nb2-ps4ll5


https://wolfram.com/xid/0e7p5nb2-eglxsu


https://wolfram.com/xid/0e7p5nb2-bnvodi

Classes Indexed by One or More Integers (90)

https://wolfram.com/xid/0e7p5nb2-u29bb0


https://wolfram.com/xid/0e7p5nb2-nfargp


https://wolfram.com/xid/0e7p5nb2-onmv01


https://wolfram.com/xid/0e7p5nb2-smctfu


https://wolfram.com/xid/0e7p5nb2-k3dm9h


https://wolfram.com/xid/0e7p5nb2-pnush3


https://wolfram.com/xid/0e7p5nb2-xzo26p


https://wolfram.com/xid/0e7p5nb2-mv23pp


https://wolfram.com/xid/0e7p5nb2-p0qa9j


https://wolfram.com/xid/0e7p5nb2-wrbi6c


https://wolfram.com/xid/0e7p5nb2-7t8058


https://wolfram.com/xid/0e7p5nb2-lhhaj0


https://wolfram.com/xid/0e7p5nb2-fta52o


https://wolfram.com/xid/0e7p5nb2-28ebbt


https://wolfram.com/xid/0e7p5nb2-zvhcsn


https://wolfram.com/xid/0e7p5nb2-ej176d


https://wolfram.com/xid/0e7p5nb2-dlsh3h


https://wolfram.com/xid/0e7p5nb2-789d6q


https://wolfram.com/xid/0e7p5nb2-1vq57c


https://wolfram.com/xid/0e7p5nb2-trtz9f


https://wolfram.com/xid/0e7p5nb2-tnzj5h

Dorogovtsev–Goltsev–Mendes graphs:

https://wolfram.com/xid/0e7p5nb2-iu9zru


https://wolfram.com/xid/0e7p5nb2-lc4eqv


https://wolfram.com/xid/0e7p5nb2-jcq5og


https://wolfram.com/xid/0e7p5nb2-uxfehf


https://wolfram.com/xid/0e7p5nb2-pqffaa


https://wolfram.com/xid/0e7p5nb2-c7pet8


https://wolfram.com/xid/0e7p5nb2-dibvdw


https://wolfram.com/xid/0e7p5nb2-qkj6ob


https://wolfram.com/xid/0e7p5nb2-tcy7f3


https://wolfram.com/xid/0e7p5nb2-0yk0bl

Goethals–Seidel block design graphs:

https://wolfram.com/xid/0e7p5nb2-jalgkr


https://wolfram.com/xid/0e7p5nb2-kuqx76


https://wolfram.com/xid/0e7p5nb2-jl7atm


https://wolfram.com/xid/0e7p5nb2-jt76ou


https://wolfram.com/xid/0e7p5nb2-ihsj0a


https://wolfram.com/xid/0e7p5nb2-vxsdd5


https://wolfram.com/xid/0e7p5nb2-gpvfuf


https://wolfram.com/xid/0e7p5nb2-b20xsu


https://wolfram.com/xid/0e7p5nb2-gxmv1f


https://wolfram.com/xid/0e7p5nb2-usnbbu


https://wolfram.com/xid/0e7p5nb2-7mfbzu


https://wolfram.com/xid/0e7p5nb2-epfh4l


https://wolfram.com/xid/0e7p5nb2-qlo0bv


https://wolfram.com/xid/0e7p5nb2-5yey83


https://wolfram.com/xid/0e7p5nb2-qm827r


https://wolfram.com/xid/0e7p5nb2-bx2bxa


https://wolfram.com/xid/0e7p5nb2-bg11d6


https://wolfram.com/xid/0e7p5nb2-j2qriy


https://wolfram.com/xid/0e7p5nb2-4qysh5


https://wolfram.com/xid/0e7p5nb2-bvqrr3


https://wolfram.com/xid/0e7p5nb2-ix9dlp

Klein bottle triangulation graphs:

https://wolfram.com/xid/0e7p5nb2-y446bv


https://wolfram.com/xid/0e7p5nb2-1atdg5


https://wolfram.com/xid/0e7p5nb2-cnw1iz


https://wolfram.com/xid/0e7p5nb2-k859yd


https://wolfram.com/xid/0e7p5nb2-clwoiw


https://wolfram.com/xid/0e7p5nb2-n1fsfd


https://wolfram.com/xid/0e7p5nb2-wop7o2


https://wolfram.com/xid/0e7p5nb2-1ftkoj


https://wolfram.com/xid/0e7p5nb2-rhmagt


https://wolfram.com/xid/0e7p5nb2-3j0r24


https://wolfram.com/xid/0e7p5nb2-x0k5fu


https://wolfram.com/xid/0e7p5nb2-ts8ypw


https://wolfram.com/xid/0e7p5nb2-mdjdj6


https://wolfram.com/xid/0e7p5nb2-3eazph


https://wolfram.com/xid/0e7p5nb2-mxp4fd


https://wolfram.com/xid/0e7p5nb2-ms6gw2


https://wolfram.com/xid/0e7p5nb2-hwg0e


https://wolfram.com/xid/0e7p5nb2-g771c6


https://wolfram.com/xid/0e7p5nb2-f9cr9f


https://wolfram.com/xid/0e7p5nb2-nlaipf


https://wolfram.com/xid/0e7p5nb2-oeko4x


https://wolfram.com/xid/0e7p5nb2-tvprrh


https://wolfram.com/xid/0e7p5nb2-k3qima


https://wolfram.com/xid/0e7p5nb2-0u34zv

Sierpiński tetrahedron graphs:

https://wolfram.com/xid/0e7p5nb2-uiingo


https://wolfram.com/xid/0e7p5nb2-no0pln


https://wolfram.com/xid/0e7p5nb2-jovudd


https://wolfram.com/xid/0e7p5nb2-yyhrd7


https://wolfram.com/xid/0e7p5nb2-cxu7n1


https://wolfram.com/xid/0e7p5nb2-gzo658


https://wolfram.com/xid/0e7p5nb2-yvs6rb


https://wolfram.com/xid/0e7p5nb2-33s6h8


https://wolfram.com/xid/0e7p5nb2-oqqk70


https://wolfram.com/xid/0e7p5nb2-j953ex


https://wolfram.com/xid/0e7p5nb2-bgf34g


https://wolfram.com/xid/0e7p5nb2-v5i0hc


https://wolfram.com/xid/0e7p5nb2-dvq0aa


https://wolfram.com/xid/0e7p5nb2-xd6lro


https://wolfram.com/xid/0e7p5nb2-vie70h


https://wolfram.com/xid/0e7p5nb2-xmfojw


https://wolfram.com/xid/0e7p5nb2-8pzrtz


https://wolfram.com/xid/0e7p5nb2-ugvu92


https://wolfram.com/xid/0e7p5nb2-stybl8


https://wolfram.com/xid/0e7p5nb2-udh7yd


https://wolfram.com/xid/0e7p5nb2-xuxkw4


https://wolfram.com/xid/0e7p5nb2-mrtps7


https://wolfram.com/xid/0e7p5nb2-38ihso


https://wolfram.com/xid/0e7p5nb2-oz6nci

Generalizations & Extensions (1)Generalized and extended use cases
Find the list of graph names matching a string wildcard expression:

https://wolfram.com/xid/0e7p5nb2-bkpbuz

Find the list of graph names matching a string expression:

https://wolfram.com/xid/0e7p5nb2-gy5uza

Find the list of graph names matching a regular expression:

https://wolfram.com/xid/0e7p5nb2-rt2yy5

Applications (8)Sample problems that can be solved with this function
Generate a list of graphs on five nodes:

https://wolfram.com/xid/0e7p5nb2-cmgi6j


https://wolfram.com/xid/0e7p5nb2-6mvlta


https://wolfram.com/xid/0e7p5nb2-jsiwhk

Generate a list of Hamiltonian graphs on five nodes:

https://wolfram.com/xid/0e7p5nb2-vtnvj6


https://wolfram.com/xid/0e7p5nb2-pnpeb4


https://wolfram.com/xid/0e7p5nb2-bwjdm2

Generate a list of Hamiltonian planar graphs on five nodes:

https://wolfram.com/xid/0e7p5nb2-0s3cut


https://wolfram.com/xid/0e7p5nb2-6v0hwo


https://wolfram.com/xid/0e7p5nb2-zxr3rt

Generate a list of graphs on five or fewer nodes:

https://wolfram.com/xid/0e7p5nb2-xlbbxa


https://wolfram.com/xid/0e7p5nb2-n1rt3n


https://wolfram.com/xid/0e7p5nb2-of4n6k

Generate an array of Cayley graphs:

https://wolfram.com/xid/0e7p5nb2-epyr6x

Visualize families of graphs by plotting edge count against vertex count:

https://wolfram.com/xid/0e7p5nb2-ujtt2m


https://wolfram.com/xid/0e7p5nb2-dyrbdv

Plot the numbers of graphs with different numbers of nodes available:

https://wolfram.com/xid/0e7p5nb2-h1cyf9

Show the five known connected vertex-transitive nonhamiltonian graphs:

https://wolfram.com/xid/0e7p5nb2-3bgzyv

Properties & Relations (10)Properties of the function, and connections to other functions
FromEntity can be used to make a graph from an entity:

https://wolfram.com/xid/0e7p5nb2-jcgdfu

A graph can also be produced from an entity using the "Graph" property:

https://wolfram.com/xid/0e7p5nb2-ddue63

ToEntity can be used to construct an entity from a graph:

https://wolfram.com/xid/0e7p5nb2-d19a0v


https://wolfram.com/xid/0e7p5nb2-ctpsbc


https://wolfram.com/xid/0e7p5nb2-wu2n6n

An entity is also returned using the GraphData "Entity" property:

https://wolfram.com/xid/0e7p5nb2-7xpaie

Give the tesseract graph using GraphData directly:

https://wolfram.com/xid/0e7p5nb2-l3tels

Do the same using the explicit "Graph" property:

https://wolfram.com/xid/0e7p5nb2-0gmkop

Construct a graph using FromEntity and the "Entity" property:

https://wolfram.com/xid/0e7p5nb2-74yd7

Construct a graph using an entity corresponding to its GraphData canonical name:

https://wolfram.com/xid/0e7p5nb2-3ij3kk

Use a member of an indexed graph family known to EntityValue:

https://wolfram.com/xid/0e7p5nb2-m8ag7f

Convert undirected graphs to graph entities using ToEntity:

https://wolfram.com/xid/0e7p5nb2-g9dgsb


https://wolfram.com/xid/0e7p5nb2-hqrfoz


https://wolfram.com/xid/0e7p5nb2-kte1xs


https://wolfram.com/xid/0e7p5nb2-lg2owl

Convert to the corresponding GraphData entity using CanonicalName:

https://wolfram.com/xid/0e7p5nb2-3b88yx

Use GraphPlot and GraphPlot3D to construct graph drawings from connectivity:

https://wolfram.com/xid/0e7p5nb2-dbrkup


https://wolfram.com/xid/0e7p5nb2-j6s9lp

Use the embedding provided by GraphData:

https://wolfram.com/xid/0e7p5nb2-63i692


https://wolfram.com/xid/0e7p5nb2-ffix2i

Show that the integral graphs have integer-valued spectra:

https://wolfram.com/xid/0e7p5nb2-i8rlra


https://wolfram.com/xid/0e7p5nb2-h3s06o


https://wolfram.com/xid/0e7p5nb2-8tfrt4

https://wolfram.com/xid/0e7p5nb2-faurwh

Show that the graphs classified as snarks satisfy their defining properties:

https://wolfram.com/xid/0e7p5nb2-l0qq7t


https://wolfram.com/xid/0e7p5nb2-31vxhe


https://wolfram.com/xid/0e7p5nb2-v1vftu


https://wolfram.com/xid/0e7p5nb2-eqqb6f

Construct an attractive symmetric embedding of the Gray graph from its LCF notation:

https://wolfram.com/xid/0e7p5nb2-o97pjp

https://wolfram.com/xid/0e7p5nb2-gtylgn


https://wolfram.com/xid/0e7p5nb2-z2a3e5

Verify that an antiprism graph is the skeleton of an antiprism:

https://wolfram.com/xid/0e7p5nb2-bspgyw


https://wolfram.com/xid/0e7p5nb2-m0yq4v

Display the corresponding PolyhedronData object:

https://wolfram.com/xid/0e7p5nb2-p7irz0

Get the skeleton graph from the polyhedron object:

https://wolfram.com/xid/0e7p5nb2-6tzj7p


https://wolfram.com/xid/0e7p5nb2-7hdymd

Show that the automorphism group of the complete graph is the symmetric group
:

https://wolfram.com/xid/0e7p5nb2-goq2rl


https://wolfram.com/xid/0e7p5nb2-z5o9x4


https://wolfram.com/xid/0e7p5nb2-7euwgc

Possible Issues (4)Common pitfalls and unexpected behavior
GraphData results are complete when the number of graphs is not too large:

https://wolfram.com/xid/0e7p5nb2-5hqjrh


https://wolfram.com/xid/0e7p5nb2-v5fe14

For queries corresponding to a large number of graphs, the list returned by GraphData may not be exhaustive:

https://wolfram.com/xid/0e7p5nb2-5u4k39


https://wolfram.com/xid/0e7p5nb2-ytn5g4

Using nonstandard graph names will not work:

https://wolfram.com/xid/0e7p5nb2-1yyoe


Use string patterns directly in GraphData:

https://wolfram.com/xid/0e7p5nb2-dmreqx

Or use general string-matching capabilities:

https://wolfram.com/xid/0e7p5nb2-f8khg


https://wolfram.com/xid/0e7p5nb2-bbeyd7

Using nonstandard property names will not work:

https://wolfram.com/xid/0e7p5nb2-dy0con


Use general string patterns to locate standard property names:

https://wolfram.com/xid/0e7p5nb2-4otl7


https://wolfram.com/xid/0e7p5nb2-kiuzee

Arithmetical operations cannot be carried out on Missing entries:

https://wolfram.com/xid/0e7p5nb2-v6837q

Remove the Missing entries before performing operations:

https://wolfram.com/xid/0e7p5nb2-3m2lt8

Display the data as a formatted table using TextGrid:

https://wolfram.com/xid/0e7p5nb2-jv4nu

Interactive Examples (1)Examples with interactive outputs
Neat Examples (3)Surprising or curious use cases
Display planar embeddings of the heptahedral graphs:

https://wolfram.com/xid/0e7p5nb2-iinb5g

See the toric structure of some of the cubic symmetric graphs:

https://wolfram.com/xid/0e7p5nb2-y0f3k3


https://wolfram.com/xid/0e7p5nb2-bm6wrv

Construct the connectivity graph of the contiguous US states plus Washington, DC:

https://wolfram.com/xid/0e7p5nb2-8w4bn5

Make a list of rules representing adjacent states:

https://wolfram.com/xid/0e7p5nb2-5c8j8m
Visualize the resulting graph:

https://wolfram.com/xid/0e7p5nb2-78b232

Check the vertex and edge counts:

https://wolfram.com/xid/0e7p5nb2-84sm8q

Compare with the counts for the "ContiguousUSAGraph":

https://wolfram.com/xid/0e7p5nb2-era7hm

Exclude four pairs of states that either share only a single point in common or have a sea border but no land border:

https://wolfram.com/xid/0e7p5nb2-l46gor
Visualize the excluded borders:

https://wolfram.com/xid/0e7p5nb2-htgqeq

Construct connectivity rules excluding these four edges:

https://wolfram.com/xid/0e7p5nb2-v2f3uw

https://wolfram.com/xid/0e7p5nb2-blky0w

Check the vertex and edge counts:

https://wolfram.com/xid/0e7p5nb2-n8hb3x

Verify this graph is isomorphic to the "ContiguousUSAGraph" using ToEntity:

https://wolfram.com/xid/0e7p5nb2-0q066r


https://wolfram.com/xid/0e7p5nb2-zfvhq5

Wolfram Research (2007), GraphData, Wolfram Language function, https://reference.wolfram.com/language/ref/GraphData.html (updated 2025).
Text
Wolfram Research (2007), GraphData, Wolfram Language function, https://reference.wolfram.com/language/ref/GraphData.html (updated 2025).
Wolfram Research (2007), GraphData, Wolfram Language function, https://reference.wolfram.com/language/ref/GraphData.html (updated 2025).
CMS
Wolfram Language. 2007. "GraphData." Wolfram Language & System Documentation Center. Wolfram Research. Last Modified 2025. https://reference.wolfram.com/language/ref/GraphData.html.
Wolfram Language. 2007. "GraphData." Wolfram Language & System Documentation Center. Wolfram Research. Last Modified 2025. https://reference.wolfram.com/language/ref/GraphData.html.
APA
Wolfram Language. (2007). GraphData. Wolfram Language & System Documentation Center. Retrieved from https://reference.wolfram.com/language/ref/GraphData.html
Wolfram Language. (2007). GraphData. Wolfram Language & System Documentation Center. Retrieved from https://reference.wolfram.com/language/ref/GraphData.html
BibTeX
@misc{reference.wolfram_2025_graphdata, author="Wolfram Research", title="{GraphData}", year="2025", howpublished="\url{https://reference.wolfram.com/language/ref/GraphData.html}", note=[Accessed: 15-April-2025
]}
BibLaTeX
@online{reference.wolfram_2025_graphdata, organization={Wolfram Research}, title={GraphData}, year={2025}, url={https://reference.wolfram.com/language/ref/GraphData.html}, note=[Accessed: 15-April-2025
]}