| Package | Description | 
|---|---|
| org.jgrapht | |
| org.jgrapht.alg | Algorithms provided with JGraphT. | 
| org.jgrapht.alg.cycle | Algorithms for enumeration of simple cycles in graphs. | 
| org.jgrapht.alg.flow | Flow related algorithms. | 
| org.jgrapht.alg.interfaces | Algorithm related interfaces. | 
| org.jgrapht.alg.isomorphism | Algorithms for (sub)graph isomorphism. | 
| org.jgrapht.alg.matching | Algorithms for the computation of matchings. | 
| org.jgrapht.alg.scoring | Vertex and/or edge scoring algorithms. | 
| org.jgrapht.alg.shortestpath | Shortest-path related algorithms. | 
| org.jgrapht.alg.spanning | Spanning tree and spanner algorithms. | 
| org.jgrapht.experimental | Experimental work or work-in-progress. | 
| org.jgrapht.experimental.alg | Experimental package with algorithms. | 
| org.jgrapht.experimental.alg.color | Experimental package with graph coloring algorithms. | 
| org.jgrapht.experimental.dag | Experimental package with directed acyclic graphs. | 
| org.jgrapht.ext | Extensions and integration means to other products. | 
| org.jgrapht.generate | Generators for graphs of various topologies. | 
| org.jgrapht.graph | Implementations of various graphs. | 
| org.jgrapht.graph.builder | Various builder for graphs. | 
| org.jgrapht.traverse | Graph traversal means. | 
| Modifier and Type | Interface and Description | 
|---|---|
| interface  | DirectedGraph<V,E>A graph whose all edges are directed. | 
| interface  | ListenableGraph<V,E>A graph that supports listeners on structural change events. | 
| interface  | UndirectedGraph<V,E>A graph whose all edges are undirected. | 
| interface  | WeightedGraph<V,E>An interface for a graph whose edges have non-uniform weights. | 
| Modifier and Type | Method and Description | 
|---|---|
| Graph<V,E> | GraphPath. getGraph()Returns the graph over which this path is defined. | 
| Modifier and Type | Method and Description | 
|---|---|
| static <V,E> boolean | Graphs. addAllEdges(Graph<? super V,? super E> destination,
           Graph<V,E> source,
           Collection<? extends E> edges)Adds a subset of the edges of the specified source graph to the specified destination graph. | 
| static <V,E> boolean | Graphs. addAllEdges(Graph<? super V,? super E> destination,
           Graph<V,E> source,
           Collection<? extends E> edges)Adds a subset of the edges of the specified source graph to the specified destination graph. | 
| static <V,E> boolean | Graphs. addAllVertices(Graph<? super V,? super E> destination,
              Collection<? extends V> vertices)Adds all of the specified vertices to the destination graph. | 
| static <V,E> E | Graphs. addEdge(Graph<V,E> g,
       V sourceVertex,
       V targetVertex,
       double weight)Creates a new edge and adds it to the specified graph similarly to the
  addEdge(Object, Object)method. | 
| static <V,E> boolean | Graphs. addEdgeWithVertices(Graph<V,E> targetGraph,
                   Graph<V,E> sourceGraph,
                   E edge)Adds the specified edge to the graph, including its vertices if not already included. | 
| static <V,E> boolean | Graphs. addEdgeWithVertices(Graph<V,E> targetGraph,
                   Graph<V,E> sourceGraph,
                   E edge)Adds the specified edge to the graph, including its vertices if not already included. | 
| static <V,E> E | Graphs. addEdgeWithVertices(Graph<V,E> g,
                   V sourceVertex,
                   V targetVertex)Adds the specified source and target vertices to the graph, if not already included, and
 creates a new edge and adds it to the specified graph similarly to the
  addEdge(Object, Object)method. | 
| static <V,E> E | Graphs. addEdgeWithVertices(Graph<V,E> g,
                   V sourceVertex,
                   V targetVertex,
                   double weight)Adds the specified source and target vertices to the graph, if not already included, and
 creates a new weighted edge and adds it to the specified graph similarly to the
  addEdge(Object, Object)method. | 
| static <V,E> boolean | Graphs. addGraph(Graph<? super V,? super E> destination,
        Graph<V,E> source)Adds all the vertices and all the edges of the specified source graph to the specified
 destination graph. | 
| static <V,E> boolean | Graphs. addGraph(Graph<? super V,? super E> destination,
        Graph<V,E> source)Adds all the vertices and all the edges of the specified source graph to the specified
 destination graph. | 
| static <V,E> V | Graphs. getOppositeVertex(Graph<V,E> g,
                 E e,
                 V v)Gets the vertex opposite another vertex across an edge. | 
| static <V,E> boolean | GraphTests. isBipartite(Graph<V,E> graph)Test whether a graph is bipartite. | 
| static <V,E> boolean | GraphTests. isBipartitePartition(Graph<V,E> graph,
                    Set<? extends V> firstPartition,
                    Set<? extends V> secondPartition)Test whether a partition of the vertices into two sets is a bipartite partition. | 
| static <V,E> boolean | GraphTests. isComplete(Graph<V,E> graph)Test whether a graph is complete. | 
| static <V,E> boolean | GraphTests. isEmpty(Graph<V,E> graph)Test whether a graph is empty. | 
| static <V,E> boolean | GraphTests. isEulerian(Graph<V,E> graph)Test whether a graph is Eulerian. | 
| static <V,E> boolean | GraphTests. isSimple(Graph<V,E> graph)Check if a graph is simple. | 
| static <V,E> List<V> | Graphs. neighborListOf(Graph<V,E> g,
              V vertex)Returns a list of vertices that are the neighbors of a specified vertex. | 
| static <V,E> boolean | Graphs. testIncidence(Graph<V,E> g,
             E e,
             V v)Tests whether an edge is incident to a vertex. | 
| static <V,E> UndirectedGraph<V,E> | Graphs. undirectedGraph(Graph<V,E> g)Returns an undirected view of the specified graph. | 
| Modifier and Type | Class and Description | 
|---|---|
| class  | BlockCutpointGraph<V,E>Definition of a block of a graph in
 MathWorld. Definition and lemma taken from the article Structure-Based Resilience Metrics for Service-Oriented Networks: Definition 4.5 Let G(V; E) be a connected undirected graph. | 
| Modifier and Type | Field and Description | 
|---|---|
| protected Graph<V,E> | BellmanFordShortestPath. graphDeprecated.  Graph on which shortest paths are searched. | 
| Modifier and Type | Method and Description | 
|---|---|
| Graph<V,E> | FloydWarshallShortestPaths. getGraph()Deprecated.  | 
| Modifier and Type | Method and Description | 
|---|---|
| static <V,E> List<E> | DijkstraShortestPath. findPathBetween(Graph<V,E> graph,
               V startVertex,
               V endVertex)Deprecated.  Convenience method to find the shortest path via a single static method call. | 
| static <V,E> List<E> | BellmanFordShortestPath. findPathBetween(Graph<V,E> graph,
               V startVertex,
               V endVertex)Deprecated.  Convenience method to find the shortest path via a single static method call. | 
| static <V,E> List<E> | BidirectionalDijkstraShortestPath. findPathBetween(Graph<V,E> graph,
               V startVertex,
               V endVertex)Deprecated.  Convenience method to find the shortest path via a single static method call. | 
| Constructor and Description | 
|---|
| AStarShortestPath(Graph<V,E> graph)Deprecated.  Create a new instance of the A* shortest path algorithm. | 
| BellmanFordShortestPath(Graph<V,E> graph,
                       V startVertex)Deprecated.  Creates an object to calculate shortest paths between the start vertex and others vertices
 using the Bellman-Ford algorithm. | 
| BellmanFordShortestPath(Graph<V,E> graph,
                       V startVertex,
                       int nMaxHops)Deprecated.  Creates an object to calculate shortest paths between the start vertex and others vertices
 using the Bellman-Ford algorithm. | 
| BellmanFordShortestPath(Graph<V,E> graph,
                       V startVertex,
                       int nMaxHops,
                       double epsilon)Deprecated.  Creates an object to calculate shortest paths between the start vertex and others vertices
 using the Bellman-Ford algorithm. | 
| BidirectionalDijkstraShortestPath(Graph<V,E> graph,
                                 V startVertex,
                                 V endVertex)Deprecated.  Creates the instance and executes the bidirectional Dijkstra shortest path algorithm. | 
| BidirectionalDijkstraShortestPath(Graph<V,E> graph,
                                 V startVertex,
                                 V endVertex,
                                 double radius)Deprecated.  Creates the instance and executes the bidirectional Dijkstra shortest path algorithm. | 
| BronKerboschCliqueFinder(Graph<V,E> graph)Creates a new clique finder. | 
| DijkstraShortestPath(Graph<V,E> graph,
                    V startVertex,
                    V endVertex)Deprecated.  Creates and executes a new DijkstraShortestPath algorithm instance. | 
| DijkstraShortestPath(Graph<V,E> graph,
                    V startVertex,
                    V endVertex,
                    double radius)Deprecated.  Creates and executes a new DijkstraShortestPath algorithm instance. | 
| FloydWarshallShortestPaths(Graph<V,E> graph)Deprecated.  Create a new instance of the Floyd-Warshall all-pairs shortest path algorithm. | 
| KruskalMinimumSpanningTree(Graph<V,E> graph)Deprecated.  Creates and executes a new KruskalMinimumSpanningTree algorithm instance. | 
| KShortestPaths(Graph<V,E> graph,
              V startVertex,
              int k)Deprecated.  Creates an object to compute ranking shortest paths between the start vertex and others
 vertices. | 
| KShortestPaths(Graph<V,E> graph,
              V startVertex,
              int nPaths,
              int nMaxHops)Deprecated.  Creates an object to calculate ranking shortest paths between the start vertex and others
 vertices. | 
| KShortestPaths(Graph<V,E> graph,
              V startVertex,
              int nPaths,
              int nMaxHops,
              PathValidator<V,E> pathValidator)Deprecated.  Creates an object to calculate ranking shortest paths between the start vertex and others
 vertices. | 
| KShortestPaths(Graph<V,E> graph,
              V startVertex,
              int k,
              PathValidator<V,E> pathValidator)Deprecated.  Creates an object to compute ranking shortest paths between the start vertex and others
 vertices. | 
| NeighborIndex(Graph<V,E> g)Creates a neighbor index for the specified undirected graph. | 
| PrimMinimumSpanningTree(Graph<V,E> g)Deprecated.  Create and execute a new instance of Prim's algorithm. | 
| TarjanLowestCommonAncestor(Graph<V,E> g)Create an instance with a reference to the graph that we will find LCAs for | 
| Modifier and Type | Method and Description | 
|---|---|
| GraphPath<V,E> | HierholzerEulerianCycle. getEulerianCycle(Graph<V,E> g)Compute an Eulerian cycle of a graph. | 
| boolean | HierholzerEulerianCycle. isEulerian(Graph<V,E> graph)Test whether a graph is Eulerian. | 
| Modifier and Type | Field and Description | 
|---|---|
| protected Graph<V,E> | MaximumFlowAlgorithmBase. network | 
| Constructor and Description | 
|---|
| EdmondsKarpMFImpl(Graph<V,E> network)Constructs MaximumFlow instance to work with a copy of network. | 
| EdmondsKarpMFImpl(Graph<V,E> network,
                 double epsilon)Constructs MaximumFlow instance to work with a copy of network. | 
| GusfieldEquivalentFlowTree(Graph<V,E> network)Constructs a new GusfieldEquivalentFlowTree instance. | 
| GusfieldEquivalentFlowTree(Graph<V,E> network,
                          double epsilon)Constructs a new GusfieldEquivalentFlowTree instance. | 
| GusfieldEquivalentFlowTree(Graph<V,E> network,
                          MinimumSTCutAlgorithm<V,E> minimumSTCutAlgorithm)Constructs a new GusfieldEquivalentFlowTree instance. | 
| GusfieldGomoryHuCutTree(Graph<V,E> network)Constructs a new GusfieldEquivalentFlowTree instance. | 
| GusfieldGomoryHuCutTree(Graph<V,E> network,
                       double epsilon)Constructs a new GusfieldEquivalentFlowTree instance. | 
| GusfieldGomoryHuCutTree(Graph<V,E> network,
                       MinimumSTCutAlgorithm<V,E> minimumSTCutAlgorithm)Constructs a new GusfieldEquivalentFlowTree instance. | 
| MaximumFlowAlgorithmBase(Graph<V,E> network,
                        double epsilon)Construct a new maximum flow | 
| PadbergRaoOddMinimumCutset(Graph<V,E> network)Creates a new instance of the PadbergRaoOddMinimumCutset algorithm. | 
| PadbergRaoOddMinimumCutset(Graph<V,E> network,
                          double epsilon)Creates a new instance of the PadbergRaoOddMinimumCutset algorithm. | 
| PadbergRaoOddMinimumCutset(Graph<V,E> network,
                          MinimumSTCutAlgorithm<V,E> minimumSTCutAlgorithm)Creates a new instance of the PadbergRaoOddMinimumCutset algorithm. | 
| PushRelabelMFImpl(Graph<V,E> network)Construct a new push-relabel algorithm. | 
| PushRelabelMFImpl(Graph<V,E> network,
                 double epsilon)Construct a new push-relabel algorithm. | 
| Modifier and Type | Method and Description | 
|---|---|
| Graph<V,E> | ShortestPathAlgorithm.SingleSourcePaths. getGraph()Returns the graph over which this set of paths is defined. | 
| Modifier and Type | Method and Description | 
|---|---|
| GraphPath<V,E> | EulerianCycleAlgorithm. getEulerianCycle(Graph<V,E> graph)Compute an Eulerian cycle of a graph. | 
| Modifier and Type | Field and Description | 
|---|---|
| protected Graph<V,E> | VF2AbstractIsomorphismInspector. graph1 | 
| protected Graph<V,E> | VF2AbstractIsomorphismInspector. graph2 | 
| Constructor and Description | 
|---|
| VF2AbstractIsomorphismInspector(Graph<V,E> graph1,
                               Graph<V,E> graph2)Construct a new base implementation of the VF2 isomorphism inspector. | 
| VF2AbstractIsomorphismInspector(Graph<V,E> graph1,
                               Graph<V,E> graph2)Construct a new base implementation of the VF2 isomorphism inspector. | 
| VF2AbstractIsomorphismInspector(Graph<V,E> graph1,
                               Graph<V,E> graph2,
                               boolean cacheEdges)Construct a new base implementation of the VF2 isomorphism inspector. | 
| VF2AbstractIsomorphismInspector(Graph<V,E> graph1,
                               Graph<V,E> graph2,
                               boolean cacheEdges)Construct a new base implementation of the VF2 isomorphism inspector. | 
| VF2AbstractIsomorphismInspector(Graph<V,E> graph1,
                               Graph<V,E> graph2,
                               Comparator<V> vertexComparator,
                               Comparator<E> edgeComparator)Construct a new base implementation of the VF2 isomorphism inspector. | 
| VF2AbstractIsomorphismInspector(Graph<V,E> graph1,
                               Graph<V,E> graph2,
                               Comparator<V> vertexComparator,
                               Comparator<E> edgeComparator)Construct a new base implementation of the VF2 isomorphism inspector. | 
| VF2AbstractIsomorphismInspector(Graph<V,E> graph1,
                               Graph<V,E> graph2,
                               Comparator<V> vertexComparator,
                               Comparator<E> edgeComparator,
                               boolean cacheEdges)Construct a new base implementation of the VF2 isomorphism inspector. | 
| VF2AbstractIsomorphismInspector(Graph<V,E> graph1,
                               Graph<V,E> graph2,
                               Comparator<V> vertexComparator,
                               Comparator<E> edgeComparator,
                               boolean cacheEdges)Construct a new base implementation of the VF2 isomorphism inspector. | 
| VF2GraphIsomorphismInspector(Graph<V,E> graph1,
                            Graph<V,E> graph2)Construct a new VF2 isomorphism inspector. | 
| VF2GraphIsomorphismInspector(Graph<V,E> graph1,
                            Graph<V,E> graph2)Construct a new VF2 isomorphism inspector. | 
| VF2GraphIsomorphismInspector(Graph<V,E> graph1,
                            Graph<V,E> graph2,
                            boolean cacheEdges)Construct a new VF2 isomorphism inspector. | 
| VF2GraphIsomorphismInspector(Graph<V,E> graph1,
                            Graph<V,E> graph2,
                            boolean cacheEdges)Construct a new VF2 isomorphism inspector. | 
| VF2GraphIsomorphismInspector(Graph<V,E> graph1,
                            Graph<V,E> graph2,
                            Comparator<V> vertexComparator,
                            Comparator<E> edgeComparator)Construct a new VF2 isomorphism inspector. | 
| VF2GraphIsomorphismInspector(Graph<V,E> graph1,
                            Graph<V,E> graph2,
                            Comparator<V> vertexComparator,
                            Comparator<E> edgeComparator)Construct a new VF2 isomorphism inspector. | 
| VF2GraphIsomorphismInspector(Graph<V,E> graph1,
                            Graph<V,E> graph2,
                            Comparator<V> vertexComparator,
                            Comparator<E> edgeComparator,
                            boolean cacheEdges)Construct a new VF2 isomorphism inspector. | 
| VF2GraphIsomorphismInspector(Graph<V,E> graph1,
                            Graph<V,E> graph2,
                            Comparator<V> vertexComparator,
                            Comparator<E> edgeComparator,
                            boolean cacheEdges)Construct a new VF2 isomorphism inspector. | 
| VF2SubgraphIsomorphismInspector(Graph<V,E> graph1,
                               Graph<V,E> graph2)Construct a new VF2 isomorphism inspector. | 
| VF2SubgraphIsomorphismInspector(Graph<V,E> graph1,
                               Graph<V,E> graph2)Construct a new VF2 isomorphism inspector. | 
| VF2SubgraphIsomorphismInspector(Graph<V,E> graph1,
                               Graph<V,E> graph2,
                               boolean cacheEdges)Construct a new VF2 isomorphism inspector. | 
| VF2SubgraphIsomorphismInspector(Graph<V,E> graph1,
                               Graph<V,E> graph2,
                               boolean cacheEdges)Construct a new VF2 isomorphism inspector. | 
| VF2SubgraphIsomorphismInspector(Graph<V,E> graph1,
                               Graph<V,E> graph2,
                               Comparator<V> vertexComparator,
                               Comparator<E> edgeComparator)Construct a new VF2 isomorphism inspector. | 
| VF2SubgraphIsomorphismInspector(Graph<V,E> graph1,
                               Graph<V,E> graph2,
                               Comparator<V> vertexComparator,
                               Comparator<E> edgeComparator)Construct a new VF2 isomorphism inspector. | 
| VF2SubgraphIsomorphismInspector(Graph<V,E> graph1,
                               Graph<V,E> graph2,
                               Comparator<V> vertexComparator,
                               Comparator<E> edgeComparator,
                               boolean cacheEdges)Construct a new VF2 isomorphism inspector. | 
| VF2SubgraphIsomorphismInspector(Graph<V,E> graph1,
                               Graph<V,E> graph2,
                               Comparator<V> vertexComparator,
                               Comparator<E> edgeComparator,
                               boolean cacheEdges)Construct a new VF2 isomorphism inspector. | 
| Constructor and Description | 
|---|
| EdmondsBlossomShrinking(Graph<V,E> graph)Construct an instance of the Edmonds blossom shrinking algorithm. | 
| GreedyWeightedMatching(Graph<V,E> graph)Create and execute a new instance of the greedy maximum weight matching algorithm. | 
| GreedyWeightedMatching(Graph<V,E> graph,
                      double epsilon)Create and execute a new instance of the greedy maximum weight matching algorithm. | 
| HopcroftKarpBipartiteMatching(Graph<V,E> graph,
                             Set<V> partition1,
                             Set<V> partition2)Construct a new instance of the Hopcroft-Karp algorithm for the computation of maximum
 matchings in bipartite graphs. | 
| KuhnMunkresMinimalWeightBipartitePerfectMatching(Graph<V,E> graph,
                                                Set<? extends V> partition1,
                                                Set<? extends V> partition2)Construct a new instance of the algorithm. | 
| MaximumWeightBipartiteMatching(Graph<V,E> graph,
                              Set<V> partition1,
                              Set<V> partition2)Construct a new instance of the algorithm. | 
| PathGrowingWeightedMatching(Graph<V,E> graph)Construct a new instance of the path growing algorithm. | 
| PathGrowingWeightedMatching(Graph<V,E> graph,
                           boolean useHeuristics)Construct a new instance of the path growing algorithm. | 
| PathGrowingWeightedMatching(Graph<V,E> graph,
                           boolean useHeuristics,
                           double epsilon)Construct a new instance of the path growing algorithm. | 
| Constructor and Description | 
|---|
| PageRank(Graph<V,E> g)Create and execute an instance of PageRank. | 
| PageRank(Graph<V,E> g,
        double dampingFactor)Create and execute an instance of PageRank. | 
| PageRank(Graph<V,E> g,
        double dampingFactor,
        int maxIterations)Create and execute an instance of PageRank. | 
| PageRank(Graph<V,E> g,
        double dampingFactor,
        int maxIterations,
        double tolerance)Create and execute an instance of PageRank. | 
| Modifier and Type | Field and Description | 
|---|---|
| protected Graph<V,E> | TreeSingleSourcePathsImpl. gThe graph | 
| protected Graph<V,E> | ListSingleSourcePathsImpl. graphThe graph | 
| Modifier and Type | Method and Description | 
|---|---|
| Graph<V,E> | ListSingleSourcePathsImpl. getGraph()Returns the graph over which this set of paths is defined. | 
| Graph<V,E> | TreeSingleSourcePathsImpl. getGraph()Returns the graph over which this set of paths is defined. | 
| Modifier and Type | Method and Description | 
|---|---|
| static <V,E> GraphPath<V,E> | DijkstraShortestPath. findPathBetween(Graph<V,E> graph,
               V source,
               V sink)Find a path between two vertices. | 
| static <V,E> GraphPath<V,E> | BellmanFordShortestPath. findPathBetween(Graph<V,E> graph,
               V source,
               V sink)Find a path between two vertices. | 
| static <V,E> GraphPath<V,E> | BidirectionalDijkstraShortestPath. findPathBetween(Graph<V,E> graph,
               V source,
               V sink)Find a path between two vertices. | 
| Constructor and Description | 
|---|
| ALTAdmissibleHeuristic(Graph<V,E> graph,
                      Set<V> landmarks)Constructs a new  AStarAdmissibleHeuristicusing a set of landmarks. | 
| AStarShortestPath(Graph<V,E> graph,
                 AStarAdmissibleHeuristic<V> admissibleHeuristic)Create a new instance of the A* shortest path algorithm. | 
| BellmanFordShortestPath(Graph<V,E> graph)Construct a new instance of the Bellman-Ford algorithm. | 
| BellmanFordShortestPath(Graph<V,E> graph,
                       int nMaxHops)Construct a new instance of the Bellman-Ford algorithm. | 
| BellmanFordShortestPath(Graph<V,E> graph,
                       int nMaxHops,
                       double epsilon)Construct a new instance of the Bellman-Ford algorithm. | 
| BidirectionalDijkstraShortestPath(Graph<V,E> graph)Constructs a new instance for a specified graph. | 
| BidirectionalDijkstraShortestPath(Graph<V,E> graph,
                                 double radius)Constructs a new instance for a specified graph. | 
| DijkstraShortestPath(Graph<V,E> graph)Constructs a new instance of the algorithm for a given graph. | 
| DijkstraShortestPath(Graph<V,E> graph,
                    double radius)Constructs a new instance of the algorithm for a given graph. | 
| FloydWarshallShortestPaths(Graph<V,E> graph)Create a new instance of the Floyd-Warshall all-pairs shortest path algorithm. | 
| KShortestPaths(Graph<V,E> graph,
              int k)Constructs an object to compute ranking shortest paths in a graph. | 
| KShortestPaths(Graph<V,E> graph,
              int k,
              int nMaxHops)Constructs an object to calculate ranking shortest paths in a graph. | 
| KShortestPaths(Graph<V,E> graph,
              int k,
              int nMaxHops,
              PathValidator<V,E> pathValidator)Constructs an object to calculate ranking shortest paths in a graph. | 
| KShortestPaths(Graph<V,E> graph,
              int k,
              PathValidator<V,E> pathValidator)Constructs an object to compute ranking shortest paths in a graph. | 
| ListSingleSourcePathsImpl(Graph<V,E> graph,
                         V source,
                         Map<V,GraphPath<V,E>> paths)Construct a new instance. | 
| TreeSingleSourcePathsImpl(Graph<V,E> g,
                         V source,
                         Map<V,Pair<Double,E>> distanceAndPredecessorMap)Construct a new instance. | 
| Constructor and Description | 
|---|
| BoruvkaMinimumSpanningTree(Graph<V,E> graph)Construct a new instance of the algorithm. | 
| KruskalMinimumSpanningTree(Graph<V,E> graph)Construct a new instance of the algorithm. | 
| PrimMinimumSpanningTree(Graph<V,E> graph)Construct a new instance of the algorithm. | 
| Modifier and Type | Class and Description | 
|---|---|
| class  | GraphSquare<V,E>A unmodifiable graph which is the squared graph of another. | 
| Constructor and Description | 
|---|
| GraphSquare(Graph<V,E> g,
           boolean createLoops)Constructor for GraphSquare. | 
| Constructor and Description | 
|---|
| IntArrayGraphAlgorithm(Graph<V,E> g)Create a new instance. | 
| Constructor and Description | 
|---|
| BrownBacktrackColoring(Graph<V,E> g)Construct a new Brown backtracking algorithm. | 
| GreedyColoring(Graph<V,E> g)Create a new greedy coloring algorithm | 
| GreedyColoring(Graph<V,E> g,
              int method)Create a new greedy coloring algorithm | 
| Modifier and Type | Class and Description | 
|---|---|
| class  | DirectedAcyclicGraph<V,E>
 DirectedAcyclicGraph implements a DAG that can be modified (vertices & edges added and
 removed), is guaranteed to remain acyclic, and provides fast topological order iteration. | 
| Modifier and Type | Method and Description | 
|---|---|
| static <V,E> String | DOTUtils. convertGraphToDotString(Graph<V,E> graph)Deprecated. 
 in favor of implementing the current functionality directly by the user | 
| static <V,E> org.jgraph.graph.AttributeMap | JGraphModelAdapter. createDefaultEdgeAttributes(Graph<V,E> jGraphTGraph)Creates and returns a map of attributes to be used as defaults for edge attributes, depending
 on the specified graph. | 
| default void | GraphExporter. exportGraph(Graph<V,E> g,
           File file)Export a graph | 
| default void | GraphExporter. exportGraph(Graph<V,E> g,
           OutputStream out)Export a graph | 
| void | MatrixExporter. exportGraph(Graph<V,E> g,
           Writer writer) | 
| void | DOTExporter. exportGraph(Graph<V,E> g,
           Writer writer)Exports a graph into a plain text file in DOT format. | 
| void | GmlExporter. exportGraph(Graph<V,E> g,
           Writer writer)Exports an graph into a plain text GML format. | 
| void | VisioExporter. exportGraph(Graph<V,E> g,
           Writer writer)Exports the specified graph into a Visio CSV file format. | 
| void | GraphExporter. exportGraph(Graph<V,E> g,
           Writer writer)Export a graph | 
| void | GraphMLExporter. exportGraph(Graph<V,E> g,
           Writer writer)Exports a graph in GraphML format. | 
| void | CSVExporter. exportGraph(Graph<V,E> g,
           Writer writer)Exports a graph | 
| void | DIMACSExporter. exportGraph(Graph<V,E> g,
           Writer writer)Export a graph | 
| default void | GraphImporter. importGraph(Graph<V,E> g,
           File file)Import a graph | 
| default void | GraphImporter. importGraph(Graph<V,E> g,
           InputStream in)Import a graph | 
| void | CSVImporter. importGraph(Graph<V,E> graph,
           Reader input)Import a graph. | 
| void | GmlImporter. importGraph(Graph<V,E> graph,
           Reader input)Import a graph. | 
| void | DOTImporter. importGraph(Graph<V,E> graph,
           Reader input)Read a dot formatted input and populate the provided graph. | 
| void | DIMACSImporter. importGraph(Graph<V,E> graph,
           Reader input)Import a graph. | 
| void | GraphImporter. importGraph(Graph<V,E> g,
           Reader in)Import a graph | 
| void | GraphMLImporter. importGraph(Graph<V,E> graph,
           Reader input)Import a graph. | 
| Constructor and Description | 
|---|
| JGraphModelAdapter(Graph<V,E> jGraphTGraph)Constructs a new JGraph model adapter for the specified JGraphT graph. | 
| JGraphModelAdapter(Graph<V,E> jGraphTGraph,
                  org.jgraph.graph.AttributeMap defaultVertexAttributes,
                  org.jgraph.graph.AttributeMap defaultEdgeAttributes)Constructs a new JGraph model adapter for the specified JGraphT graph. | 
| JGraphModelAdapter(Graph<V,E> jGraphTGraph,
                  org.jgraph.graph.AttributeMap defaultVertexAttributes,
                  org.jgraph.graph.AttributeMap defaultEdgeAttributes,
                  JGraphModelAdapter.CellFactory<V,E> cellFactory)Constructs a new JGraph model adapter for the specified JGraphT graph. | 
| JGraphXAdapter(Graph<V,E> graph)Constructs and draws a new mxGraph from a jGraphT graph. | 
| Constructor and Description | 
|---|
| DOTExporter(ComponentNameProvider<V> vertexIDProvider,
           ComponentNameProvider<V> vertexLabelProvider,
           ComponentNameProvider<E> edgeLabelProvider,
           ComponentAttributeProvider<V> vertexAttributeProvider,
           ComponentAttributeProvider<E> edgeAttributeProvider,
           ComponentNameProvider<Graph<V,E>> graphIDProvider)Constructs a new DOTExporter object with the given ID, label, attribute, and graph id
 providers. | 
| DOTImporter(VertexProvider<V> vertexProvider,
           EdgeProvider<V,E> edgeProvider,
           ComponentUpdater<V> vertexUpdater,
           ComponentUpdater<Graph<V,E>> graphUpdater)Constructs a new DOTImporter with the given providers | 
| Modifier and Type | Method and Description | 
|---|---|
| void | GraphGenerator. generateGraph(Graph<V,E> target,
             VertexFactory<V> vertexFactory,
             Map<String,T> resultMap)Generate a graph structure. | 
| void | WeightedGraphGeneratorAdapter. generateGraph(Graph<V,E> target,
             VertexFactory<V> vertexFactory,
             Map<String,T> resultMap)Generate a graph structure. | 
| void | GnpRandomBipartiteGraphGenerator. generateGraph(Graph<V,E> target,
             VertexFactory<V> vertexFactory,
             Map<String,V> resultMap)Generates a random bipartite graph. | 
| void | EmptyGraphGenerator. generateGraph(Graph<V,E> target,
             VertexFactory<V> vertexFactory,
             Map<String,V> resultMap)Generate a graph structure. | 
| void | WheelGraphGenerator. generateGraph(Graph<V,E> target,
             VertexFactory<V> vertexFactory,
             Map<String,V> resultMap)Generate a graph structure. | 
| void | CompleteBipartiteGraphGenerator. generateGraph(Graph<V,E> target,
             VertexFactory<V> vertexFactory,
             Map<String,V> resultMap)Construct a complete bipartite graph | 
| void | StarGraphGenerator. generateGraph(Graph<V,E> target,
             VertexFactory<V> vertexFactory,
             Map<String,V> resultMap)Generates a star graph with the designated order from the constructor | 
| void | LinearGraphGenerator. generateGraph(Graph<V,E> target,
             VertexFactory<V> vertexFactory,
             Map<String,V> resultMap)Generate a graph structure. | 
| void | HyperCubeGraphGenerator. generateGraph(Graph<V,E> target,
             VertexFactory<V> vertexFactory,
             Map<String,V> resultMap)This will generate the hypercube graph | 
| void | GnpRandomGraphGenerator. generateGraph(Graph<V,E> target,
             VertexFactory<V> vertexFactory,
             Map<String,V> resultMap)Generates a random graph based on the G(n, p) model. | 
| void | GnmRandomBipartiteGraphGenerator. generateGraph(Graph<V,E> target,
             VertexFactory<V> vertexFactory,
             Map<String,V> resultMap)Generates a random bipartite graph. | 
| void | GridGraphGenerator. generateGraph(Graph<V,E> target,
             VertexFactory<V> vertexFactory,
             Map<String,V> resultMap)Generate a graph structure. | 
| void | GnmRandomGraphGenerator. generateGraph(Graph<V,E> target,
             VertexFactory<V> vertexFactory,
             Map<String,V> resultMap)Generates a random graph based on the G(n, M) model | 
| void | CompleteGraphGenerator. generateGraph(Graph<V,E> target,
             VertexFactory<V> vertexFactory,
             Map<String,V> resultMap)Generate a graph structure. | 
| void | RingGraphGenerator. generateGraph(Graph<V,E> target,
             VertexFactory<V> vertexFactory,
             Map<String,V> resultMap)Generate a graph structure. | 
| void | ScaleFreeGraphGenerator. generateGraph(Graph<V,E> target,
             VertexFactory<V> vertexFactory,
             Map<String,V> resultMap)Generates scale-free network with size passed to the constructor. | 
| Modifier and Type | Class and Description | 
|---|---|
| class  | GraphUnion<V,E,G extends Graph<V,E>>
 Read-only union of two graphs: G1 and G2. | 
| class  | Subgraph<V,E,G extends Graph<V,E>>A subgraph is a graph that has a subset of vertices and a subset of edges with respect to some
 base graph. | 
| Modifier and Type | Class and Description | 
|---|---|
| class  | AbstractBaseGraph<V,E>The most general implementation of the  Graphinterface. | 
| class  | AbstractGraph<V,E>A skeletal implementation of the Graph interface, to minimize the effort required to
 implement graph interfaces. | 
| class  | AsUndirectedGraph<V,E>An undirected view of the backing directed graph specified in the constructor. | 
| class  | AsUnweightedDirectedGraph<V,E>An unweighted view of the backing weighted graph specified in the constructor. | 
| class  | AsUnweightedGraph<V,E>An unweighted view of the backing weighted graph specified in the constructor. | 
| class  | AsWeightedDirectedGraph<V,E>
 A weighted view of the backing graph specified in the constructor. | 
| class  | AsWeightedGraph<V,E>
 A weighted view of the backing graph specified in the constructor. | 
| class  | DefaultDirectedGraph<V,E>A directed graph. | 
| class  | DefaultDirectedWeightedGraph<V,E>A directed weighted graph. | 
| class  | DefaultListenableGraph<V,E>A graph backed by the the graph specified at the constructor, which can be listened by
  GraphListeners and by
 VertexSetListeners. | 
| class  | DirectedGraphUnion<V,E>A union of directed graphs. | 
| class  | DirectedMaskSubgraph<V,E>A directed graph that is a  MaskSubgraphof another graph. | 
| class  | DirectedMultigraph<V,E>A directed multigraph. | 
| class  | DirectedPseudograph<V,E>A directed pseudograph. | 
| class  | DirectedSubgraph<V,E>A directed graph that is a subgraph of another graph. | 
| class  | DirectedWeightedMultigraph<V,E>A directed weighted multigraph. | 
| class  | DirectedWeightedPseudograph<V,E>A directed weighted pseudograph. | 
| class  | DirectedWeightedSubgraph<V,E>A directed weighted graph that is a subgraph of another graph. | 
| class  | EdgeReversedGraph<V,E>Provides an edge-reversed view g' of a directed graph g. | 
| class  | GraphDelegator<V,E>A graph backed by the the graph specified at the constructor, which delegates all its methods to
 the backing graph. | 
| class  | GraphUnion<V,E,G extends Graph<V,E>>
 Read-only union of two graphs: G1 and G2. | 
| class  | ListenableDirectedGraph<V,E>A directed graph which is also  ListenableGraph. | 
| class  | ListenableDirectedWeightedGraph<V,E>A directed weighted graph which is also  ListenableGraph. | 
| class  | ListenableUndirectedGraph<V,E>An undirected graph which is also  ListenableGraph. | 
| class  | ListenableUndirectedWeightedGraph<V,E>An undirected weighted graph which is also  ListenableGraph. | 
| class  | MaskSubgraph<V,E>An unmodifiable subgraph induced by a vertex/edge masking function. | 
| class  | MixedGraphUnion<V,E>Read-only union of an undirected and a directed graph. | 
| class  | Multigraph<V,E>A multigraph. | 
| class  | ParanoidGraph<V,E>ParanoidGraph provides a way to verify that objects added to a graph obey the standard
 equals/hashCode contract. | 
| class  | Pseudograph<V,E>A pseudograph. | 
| class  | SimpleDirectedGraph<V,E>A simple directed graph. | 
| class  | SimpleDirectedWeightedGraph<V,E>A simple directed weighted graph. | 
| class  | SimpleGraph<V,E>A simple graph. | 
| class  | SimpleWeightedGraph<V,E>A simple weighted graph. | 
| class  | Subgraph<V,E,G extends Graph<V,E>>A subgraph is a graph that has a subset of vertices and a subset of edges with respect to some
 base graph. | 
| class  | UndirectedGraphUnion<V,E>An undirected version of the read-only union of two graphs. | 
| class  | UndirectedMaskSubgraph<V,E>An undirected graph that is a  MaskSubgraphof another graph. | 
| class  | UndirectedSubgraph<V,E>An undirected graph that is a subgraph of another graph. | 
| class  | UndirectedWeightedSubgraph<V,E>An undirected weighted graph that is a subgraph on other graph. | 
| class  | UnmodifiableDirectedGraph<V,E>A directed graph that cannot be modified. | 
| class  | UnmodifiableGraph<V,E>An unmodifiable view of the backing graph specified in the constructor. | 
| class  | UnmodifiableUndirectedGraph<V,E>An undirected graph that cannot be modified. | 
| class  | WeightedMultigraph<V,E>A weighted multigraph. | 
| class  | WeightedPseudograph<V,E>A weighted pseudograph. | 
| Modifier and Type | Field and Description | 
|---|---|
| protected Graph<V,E> | MaskSubgraph. base | 
| protected G | Subgraph. base | 
| protected Graph<V,E> | GraphWalk. graph | 
| Modifier and Type | Method and Description | 
|---|---|
| Graph<V,E> | GraphWalk. getGraph() | 
| Constructor and Description | 
|---|
| AsUnweightedGraph(Graph<V,E> g)Constructor for AsUnweightedGraph. | 
| AsWeightedGraph(Graph<V,E> g,
               Map<E,Double> weightMap)Constructor for AsWeightedGraph. | 
| DefaultGraphMapping(Map<V,V> g1ToG2,
                   Map<V,V> g2ToG1,
                   Graph<V,E> g1,
                   Graph<V,E> g2)The maps themselves are used. | 
| DefaultGraphMapping(Map<V,V> g1ToG2,
                   Map<V,V> g2ToG1,
                   Graph<V,E> g1,
                   Graph<V,E> g2)The maps themselves are used. | 
| DefaultListenableGraph(Graph<V,E> g)Creates a new listenable graph. | 
| DefaultListenableGraph(Graph<V,E> g,
                      boolean reuseEvents)Creates a new listenable graph. | 
| GraphDelegator(Graph<V,E> g)Constructor for GraphDelegator. | 
| GraphWalk(Graph<V,E> graph,
         List<V> vertexList,
         double weight)Creates a walk defined by a sequence of vertices. | 
| GraphWalk(Graph<V,E> graph,
         V startVertex,
         V endVertex,
         List<E> edgeList,
         double weight)Creates a walk defined by a sequence of edges. | 
| GraphWalk(Graph<V,E> graph,
         V startVertex,
         V endVertex,
         List<V> vertexList,
         List<E> edgeList,
         double weight)Creates a walk defined by both a sequence of edges and a sequence of vertices. | 
| MaskSubgraph(Graph<V,E> base,
            MaskFunctor<V,E> mask)Deprecated. 
 in favor of using the constructor with lambdas | 
| MaskSubgraph(Graph<V,E> base,
            java.util.function.Predicate<V> vertexMask,
            java.util.function.Predicate<E> edgeMask)Creates a new induced subgraph. | 
| ParanoidGraph(Graph<V,E> g)Create a new paranoid graph. | 
| UnmodifiableGraph(Graph<V,E> g)Creates a new unmodifiable graph based on the specified backing graph. | 
| Modifier and Type | Class and Description | 
|---|---|
| class  | AbstractGraphBuilder<V,E,G extends Graph<V,E>,B extends AbstractGraphBuilder<V,E,G,B>>Base class for builders of  Graph | 
| Modifier and Type | Field and Description | 
|---|---|
| protected G | AbstractGraphBuilder. graph | 
| Modifier and Type | Method and Description | 
|---|---|
| B | AbstractGraphBuilder. addGraph(Graph<? extends V,? extends E> sourceGraph)Adds all the vertices and all the edges of the  sourceGraphto the graph being built. | 
| Modifier and Type | Method and Description | 
|---|---|
| Graph<V,E> | CrossComponentIterator. getGraph() | 
| Constructor and Description | 
|---|
| BreadthFirstIterator(Graph<V,E> g)Creates a new breadth-first iterator for the specified graph. | 
| BreadthFirstIterator(Graph<V,E> g,
                    V startVertex)Creates a new breadth-first iterator for the specified graph. | 
| ClosestFirstIterator(Graph<V,E> g)Creates a new closest-first iterator for the specified graph. | 
| ClosestFirstIterator(Graph<V,E> g,
                    V startVertex)Creates a new closest-first iterator for the specified graph. | 
| ClosestFirstIterator(Graph<V,E> g,
                    V startVertex,
                    double radius)Creates a new radius-bounded closest-first iterator for the specified graph. | 
| CrossComponentIterator(Graph<V,E> g,
                      V startVertex)Creates a new iterator for the specified graph. | 
| DepthFirstIterator(Graph<V,E> g)Creates a new depth-first iterator for the specified graph. | 
| DepthFirstIterator(Graph<V,E> g,
                  V startVertex)Creates a new depth-first iterator for the specified graph. | 
| RandomWalkIterator(Graph<V,E> graph)Creates a new iterator for the specified graph. | 
| RandomWalkIterator(Graph<V,E> graph,
                  V startVertex)Creates a new iterator for the specified graph. | 
| RandomWalkIterator(Graph<V,E> graph,
                  V startVertex,
                  boolean isWeighted)Creates a new iterator for the specified graph. | 
| RandomWalkIterator(Graph<V,E> graph,
                  V startVertex,
                  boolean isWeighted,
                  long maxSteps)Creates a new iterator for the specified graph. | 
Copyright © 2017. All rights reserved.