Package | Description |
---|---|
edu.uci.ics.jung.algorithms.blockmodel |
Support for establishing and maintaining graph element equivalence (such as in blockmodeling).
|
edu.uci.ics.jung.algorithms.cluster |
Mechanisms for identifying clusters in graphs.
|
edu.uci.ics.jung.algorithms.filters |
Filtering mechanisms that produce subgraphs of an original graph.
|
edu.uci.ics.jung.algorithms.generators |
Methods for generating new (often random) graphs with various properties.
|
edu.uci.ics.jung.algorithms.generators.random |
Methods for generating random graphs with various properties.
|
edu.uci.ics.jung.algorithms.importance | |
edu.uci.ics.jung.algorithms.layout |
Algorithms for assigning 2D coordinates (typically used for graph visualizations)
to vertices.
|
edu.uci.ics.jung.algorithms.metrics |
Specialized measures for graph properties.
|
edu.uci.ics.jung.algorithms.scoring |
Mechanisms for assigning values (denoting significance, influence, centrality, etc.)
to graph elements based on topological properties.
|
edu.uci.ics.jung.algorithms.scoring.util |
Utility functions for assigning scores to graph elements.
|
edu.uci.ics.jung.algorithms.shortestpath |
Provides interfaces and classes for calculating (geodesic) distances and shortest paths.
|
edu.uci.ics.jung.algorithms.transformation |
Mechanisms for graph transformation.
|
edu.uci.ics.jung.algorithms.util |
Provides general algorithmic utilities.
|
edu.uci.ics.jung.graph |
Interfaces for the JUNG graph types, and some representative implementations.
|
edu.uci.ics.jung.graph.event |
Support for generating events in response to graph actions, especially mutations.
|
edu.uci.ics.jung.graph.util |
Utility interfaces and classes for the JUNG API.
|
edu.uci.ics.jung.io |
Interfaces and classes for reading and writing graphs in various (file)
formats.
|
edu.uci.ics.jung.samples |
Sample applications created using JUNG, largely focused on visualization.
|
edu.uci.ics.jung.visualization |
Frameworks and mechanisms for visualizing JUNG graphs using Swing/AWT.
|
edu.uci.ics.jung.visualization.decorators |
Mechanisms for associating data (shapes, colors, values, strings, etc.) with
graph elements.
|
edu.uci.ics.jung.visualization.layout |
Visualization mechanisms related to graph layout: caching, persistence,
event-emitting, etc.
|
edu.uci.ics.jung.visualization.picking |
Visualization mechanisms for supporting the selection of graph elements.
|
edu.uci.ics.jung.visualization.subLayout |
Visualization mechanisms relating to grouping or hiding specified element sets.
|
edu.uci.ics.jung.visualization.util |
Utilities for graph visualization.
|
Modifier and Type | Method and Description |
---|---|
Graph<V,E> |
VertexPartition.getGraph()
Returns the graph on which the partition is defined.
|
Modifier and Type | Method and Description |
---|---|
protected Set<Pair<V>> |
StructurallyEquivalent.getEquivalentPairs(Graph<V,?> g)
For each vertex pair v, v1 in G, checks whether v and v1 are fully
equivalent: meaning that they connect to the exact same vertices.
|
protected boolean |
StructurallyEquivalent.isStructurallyEquivalent(Graph<V,?> g,
V v1,
V v2)
Checks whether a pair of vertices are structurally equivalent.
|
VertexPartition<V,E> |
StructurallyEquivalent.transform(Graph<V,E> g) |
Constructor and Description |
---|
VertexPartition(Graph<V,E> g,
Collection<Set<V>> vertex_sets)
Creates an instance based on the specified graph and set of disjoint vertex sets,
and generates a vertex-to-partition map based on these sets.
|
VertexPartition(Graph<V,E> g,
Map<V,Set<V>> partition_map)
Creates an instance based on the specified graph and mapping from vertices
to vertex sets, and generates a set of partitions based on this mapping.
|
VertexPartition(Graph<V,E> g,
Map<V,Set<V>> partition_map,
Collection<Set<V>> vertex_sets)
Creates an instance based on the specified graph, vertex-set mapping,
and set of disjoint vertex sets.
|
Modifier and Type | Field and Description |
---|---|
protected Graph<V,E> |
VoltageClusterer.g |
Modifier and Type | Method and Description |
---|---|
Set<Set<V>> |
EdgeBetweennessClusterer.transform(Graph<V,E> graph)
Finds the set of clusters which have the strongest "community structure".
|
Set<Set<V>> |
WeakComponentClusterer.transform(Graph<V,E> graph)
Extracts the weak components from a graph.
|
Constructor and Description |
---|
VoltageClusterer(Graph<V,E> g,
int num_candidates)
Creates an instance of a VoltageCluster with the specified parameters.
|
Modifier and Type | Method and Description |
---|---|
Graph<V,E> |
VertexPredicateFilter.transform(Graph<V,E> g) |
Graph<V,E> |
EdgePredicateFilter.transform(Graph<V,E> g) |
Graph<V,E> |
KNeighborhoodFilter.transform(Graph<V,E> graph)
Constructs an unassembled graph containing the k-neighborhood around the root node(s).
|
Modifier and Type | Method and Description |
---|---|
Graph<V,E> |
VertexPredicateFilter.transform(Graph<V,E> g) |
Graph<V,E> |
EdgePredicateFilter.transform(Graph<V,E> g) |
Graph<V,E> |
KNeighborhoodFilter.transform(Graph<V,E> graph)
Constructs an unassembled graph containing the k-neighborhood around the root node(s).
|
Modifier and Type | Field and Description |
---|---|
protected org.apache.commons.collections4.Factory<? extends Graph<V,E>> |
Lattice2DGenerator.graph_factory |
Modifier and Type | Method and Description |
---|---|
Graph<V,E> |
Lattice2DGenerator.create() |
Constructor and Description |
---|
Lattice2DGenerator(org.apache.commons.collections4.Factory<? extends Graph<V,E>> graph_factory,
org.apache.commons.collections4.Factory<V> vertex_factory,
org.apache.commons.collections4.Factory<E> edge_factory,
int latticeSize,
boolean isToroidal)
Constructs a generator of square lattices of size
latticeSize
with the specified parameters. |
Lattice2DGenerator(org.apache.commons.collections4.Factory<? extends Graph<V,E>> graph_factory,
org.apache.commons.collections4.Factory<V> vertex_factory,
org.apache.commons.collections4.Factory<E> edge_factory,
int row_count,
int col_count,
boolean isToroidal)
Creates a generator of
row_count x col_count lattices
with the specified parameters. |
Modifier and Type | Field and Description |
---|---|
protected org.apache.commons.collections4.Factory<Graph<V,E>> |
BarabasiAlbertGenerator.graphFactory |
Modifier and Type | Method and Description |
---|---|
Graph<V,E> |
KleinbergSmallWorldGenerator.create()
Generates a random small world network according to the parameters given
|
Graph<V,E> |
EppsteinPowerLawGenerator.create()
Generates a graph whose degree distribution approximates a power-law.
|
Graph<V,E> |
BarabasiAlbertGenerator.create() |
Graph<V,E> |
ErdosRenyiGenerator.create()
Returns a graph in which each pair of vertices is connected by
an undirected edge with the probability specified by the constructor.
|
static <V,E> Graph<V,E> |
MixedRandomGraphGenerator.generateMixedRandomGraph(org.apache.commons.collections4.Factory<Graph<V,E>> graphFactory,
org.apache.commons.collections4.Factory<V> vertexFactory,
org.apache.commons.collections4.Factory<E> edgeFactory,
Map<E,Number> edge_weights,
int num_vertices,
boolean parallel,
Set<V> seedVertices)
Returns a random mixed-mode graph.
|
static <V,E> Graph<V,E> |
MixedRandomGraphGenerator.generateMixedRandomGraph(org.apache.commons.collections4.Factory<Graph<V,E>> graphFactory,
org.apache.commons.collections4.Factory<V> vertexFactory,
org.apache.commons.collections4.Factory<E> edgeFactory,
Map<E,Number> edge_weight,
int num_vertices,
Set<V> seedVertices)
Equivalent to
generateMixedRandomGraph(edge_weight, num_vertices, true) . |
protected Graph<V,E> |
EppsteinPowerLawGenerator.initializeGraph() |
Modifier and Type | Method and Description |
---|---|
static <V,E> Graph<V,E> |
MixedRandomGraphGenerator.generateMixedRandomGraph(org.apache.commons.collections4.Factory<Graph<V,E>> graphFactory,
org.apache.commons.collections4.Factory<V> vertexFactory,
org.apache.commons.collections4.Factory<E> edgeFactory,
Map<E,Number> edge_weights,
int num_vertices,
boolean parallel,
Set<V> seedVertices)
Returns a random mixed-mode graph.
|
static <V,E> Graph<V,E> |
MixedRandomGraphGenerator.generateMixedRandomGraph(org.apache.commons.collections4.Factory<Graph<V,E>> graphFactory,
org.apache.commons.collections4.Factory<V> vertexFactory,
org.apache.commons.collections4.Factory<E> edgeFactory,
Map<E,Number> edge_weight,
int num_vertices,
Set<V> seedVertices)
Equivalent to
generateMixedRandomGraph(edge_weight, num_vertices, true) . |
Constructor and Description |
---|
BarabasiAlbertGenerator(org.apache.commons.collections4.Factory<Graph<V,E>> graphFactory,
org.apache.commons.collections4.Factory<V> vertexFactory,
org.apache.commons.collections4.Factory<E> edgeFactory,
int init_vertices,
int numEdgesToAttach,
int seed,
Set<V> seedVertices)
Constructs a new instance of the generator.
|
BarabasiAlbertGenerator(org.apache.commons.collections4.Factory<Graph<V,E>> graphFactory,
org.apache.commons.collections4.Factory<V> vertexFactory,
org.apache.commons.collections4.Factory<E> edgeFactory,
int init_vertices,
int numEdgesToAttach,
Set<V> seedVertices)
Constructs a new instance of the generator, whose output will be an undirected graph,
and which will use the current time as a seed for the random number generation.
|
EppsteinPowerLawGenerator(org.apache.commons.collections4.Factory<Graph<V,E>> graphFactory,
org.apache.commons.collections4.Factory<V> vertexFactory,
org.apache.commons.collections4.Factory<E> edgeFactory,
int numVertices,
int numEdges,
int r)
Creates an instance with the specified factories and specifications.
|
KleinbergSmallWorldGenerator(org.apache.commons.collections4.Factory<? extends Graph<V,E>> graph_factory,
org.apache.commons.collections4.Factory<V> vertex_factory,
org.apache.commons.collections4.Factory<E> edge_factory,
int latticeSize,
double clusteringExponent)
Creates
|
KleinbergSmallWorldGenerator(org.apache.commons.collections4.Factory<? extends Graph<V,E>> graph_factory,
org.apache.commons.collections4.Factory<V> vertex_factory,
org.apache.commons.collections4.Factory<E> edge_factory,
int row_count,
int col_count,
double clusteringExponent) |
KleinbergSmallWorldGenerator(org.apache.commons.collections4.Factory<? extends Graph<V,E>> graph_factory,
org.apache.commons.collections4.Factory<V> vertex_factory,
org.apache.commons.collections4.Factory<E> edge_factory,
int row_count,
int col_count,
double clusteringExponent,
boolean isToroidal) |
Modifier and Type | Method and Description |
---|---|
protected Graph<V,E> |
AbstractRanker.getGraph() |
Modifier and Type | Method and Description |
---|---|
protected void |
BetweennessCentrality.computeBetweenness(Graph<V,E> graph) |
protected void |
AbstractRanker.initialize(Graph<V,E> graph,
boolean isNodeRanker,
boolean isEdgeRanker) |
Constructor and Description |
---|
BetweennessCentrality(Graph<V,E> g)
Constructor which initializes the algorithm
|
BetweennessCentrality(Graph<V,E> g,
boolean rankNodes) |
BetweennessCentrality(Graph<V,E> g,
boolean rankNodes,
boolean rankEdges) |
Modifier and Type | Field and Description |
---|---|
protected Graph<V,E> |
AbstractLayout.graph |
Modifier and Type | Method and Description |
---|---|
Graph<V,E> |
Layout.getGraph()
Returns the full graph (the one that was passed in at
construction time) that this Layout refers to.
|
Graph<V,E> |
AggregateLayout.getGraph()
Returns the graph for which this layout is defined.
|
Graph<V,E> |
TreeLayout.getGraph() |
Graph<V,E> |
LayoutDecorator.getGraph() |
Graph<V,E> |
AbstractLayout.getGraph()
Accessor for the graph that represets all vertices.
|
Modifier and Type | Method and Description |
---|---|
void |
Layout.setGraph(Graph<V,E> graph)
setter for graph
|
void |
AggregateLayout.setGraph(Graph<V,E> graph) |
void |
TreeLayout.setGraph(Graph<V,E> graph) |
void |
LayoutDecorator.setGraph(Graph<V,E> graph) |
void |
AbstractLayout.setGraph(Graph<V,E> graph) |
void |
DAGLayout.setRoot(Graph<V,E> g)
setRoot calculates the level of each vertex in the graph.
|
Constructor and Description |
---|
AbstractLayout(Graph<V,E> graph)
Creates an instance which does not initialize the vertex locations.
|
AbstractLayout(Graph<V,E> graph,
Dimension size) |
AbstractLayout(Graph<V,E> graph,
org.apache.commons.collections4.Transformer<V,Point2D> initializer) |
AbstractLayout(Graph<V,E> graph,
org.apache.commons.collections4.Transformer<V,Point2D> initializer,
Dimension size) |
CircleLayout(Graph<V,E> g)
Creates an instance for the specified graph.
|
DAGLayout(Graph<V,E> g)
Creates an instance for the specified graph.
|
FRLayout(Graph<V,E> g)
Creates an instance for the specified graph.
|
FRLayout(Graph<V,E> g,
Dimension d)
Creates an instance of size
d for the specified graph. |
FRLayout2(Graph<V,E> g)
Creates an instance for the specified graph.
|
FRLayout2(Graph<V,E> g,
Dimension d)
Creates an instance of size
d for the specified graph. |
ISOMLayout(Graph<V,E> g)
Creates an
ISOMLayout instance for the specified graph g . |
KKLayout(Graph<V,E> g)
Creates an instance for the specified graph.
|
KKLayout(Graph<V,E> g,
Distance<V> distance)
Creates an instance for the specified graph and distance metric.
|
SpringLayout(Graph<V,E> g)
Constructor for a SpringLayout for a raw graph with associated
dimension--the input knows how big the graph is.
|
SpringLayout(Graph<V,E> g,
org.apache.commons.collections4.Transformer<E,Integer> length_function)
Constructor for a SpringLayout for a raw graph with associated component.
|
SpringLayout2(Graph<V,E> g)
Constructor for a SpringLayout for a raw graph with associated
dimension--the input knows how big the graph is.
|
SpringLayout2(Graph<V,E> g,
org.apache.commons.collections4.Transformer<E,Integer> length_function)
Constructor for a SpringLayout for a raw graph with associated component.
|
StaticLayout(Graph<V,E> graph)
Creates an instance for the specified graph and default size; vertex locations
are randomly assigned.
|
StaticLayout(Graph<V,E> graph,
Dimension size)
Creates an instance for the specified graph and size.
|
StaticLayout(Graph<V,E> graph,
org.apache.commons.collections4.Transformer<V,Point2D> initializer)
Creates an instance for the specified graph and locations, with default size.
|
StaticLayout(Graph<V,E> graph,
org.apache.commons.collections4.Transformer<V,Point2D> initializer,
Dimension size)
Creates an instance for the specified graph, locations, and size.
|
Modifier and Type | Field and Description |
---|---|
protected Graph<V,E> |
StructuralHoles.g |
Modifier and Type | Method and Description |
---|---|
static <V,E> Map<V,Double> |
Metrics.clusteringCoefficients(Graph<V,E> graph)
Returns a
Map of vertices to their clustering coefficients. |
protected static <V,E> boolean |
TriadicCensus.link(Graph<V,E> g,
V a,
V b) |
protected double |
StructuralHoles.organizationalMeasure(Graph<V,E> g,
V v)
A measure of the organization of individuals within the subgraph
centered on
v . |
protected static <V,E> boolean |
TriadicCensus.shouldCount(Graph<V,E> g,
List<V> id,
V u,
V v,
V w)
Make sure we have a canonical ordering: Returns true if u < w, or v < w <
u and v doesn't link to w
|
static <V,E> int |
TriadicCensus.triCode(Graph<V,E> g,
V u,
V v,
V w)
This is the core of the technique in the paper.
|
Constructor and Description |
---|
StructuralHoles(Graph<V,E> graph,
org.apache.commons.collections4.Transformer<E,? extends Number> nev)
Creates a
StructuralHoles instance based on the
edge weights specified by nev . |
Modifier and Type | Field and Description |
---|---|
protected Graph<V,E> |
BetweennessCentrality.graph |
Modifier and Type | Method and Description |
---|---|
protected void |
BetweennessCentrality.initialize(Graph<V,E> graph) |
Constructor and Description |
---|
BetweennessCentrality(Graph<V,E> graph)
Calculates betweenness scores based on the all-pairs unweighted shortest paths
in the graph.
|
BetweennessCentrality(Graph<V,E> graph,
org.apache.commons.collections4.Transformer<E,? extends Number> edge_weights)
Calculates betweenness scores based on the all-pairs weighted shortest paths in the
graph.
|
HITS(Graph<V,E> g)
Creates an instance for the specified graph.
|
HITS(Graph<V,E> g,
double alpha)
Creates an instance for the specified graph and alpha (random jump probability)
parameter.
|
HITS(Graph<V,E> g,
org.apache.commons.collections4.Transformer<E,Double> edge_weights,
double alpha)
Creates an instance for the specified graph, edge weights, and alpha
(random jump probability) parameter.
|
Modifier and Type | Field and Description |
---|---|
protected Graph<V,E> |
UniformInOut.graph
The graph for which the edge weights are defined.
|
Constructor and Description |
---|
UniformInOut(Graph<V,E> graph)
Creates an instance for the specified graph.
|
Modifier and Type | Field and Description |
---|---|
protected Graph<V,E> |
MinimumSpanningForest2.graph |
protected Graph<V,E> |
MinimumSpanningForest.graph |
Modifier and Type | Field and Description |
---|---|
protected org.apache.commons.collections4.Factory<? extends Graph<V,E>> |
PrimMinimumSpanningTree.treeFactory |
Modifier and Type | Method and Description |
---|---|
Graph<V,E> |
PrimMinimumSpanningTree.transform(Graph<V,E> graph) |
Modifier and Type | Method and Description |
---|---|
protected V |
PrimMinimumSpanningTree.findRoot(Graph<V,E> graph) |
static <V,E> List<E> |
ShortestPathUtils.getPath(Graph<V,E> graph,
ShortestPath<V,E> sp,
V source,
V target)
Returns a
List of the edges on the shortest path from
source to target , in order of their
occurrence on this path. |
Graph<V,E> |
PrimMinimumSpanningTree.transform(Graph<V,E> graph) |
protected void |
PrimMinimumSpanningTree.updateTree(Graph<V,E> tree,
Graph<V,E> graph,
Collection<E> unfinishedEdges) |
protected void |
PrimMinimumSpanningTree.updateTree(Graph<V,E> tree,
Graph<V,E> graph,
Collection<E> unfinishedEdges) |
Constructor and Description |
---|
DijkstraDistance(Graph<V,E> g)
Creates an instance of
DijkstraShortestPath for
the specified unweighted graph (that is, all weights 1) which
caches results locally. |
DijkstraDistance(Graph<V,E> g,
boolean cached)
Creates an instance of
DijkstraShortestPath for
the specified unweighted graph (that is, all weights 1) which
caches results locally. |
DijkstraShortestPath(Graph<V,E> g)
Creates an instance of
DijkstraShortestPath for
the specified unweighted graph (that is, all weights 1) which
caches results locally. |
DijkstraShortestPath(Graph<V,E> g,
boolean cached)
Creates an instance of
DijkstraShortestPath for
the specified unweighted graph (that is, all weights 1) which
caches results locally. |
DijkstraShortestPath(Graph<V,E> g,
org.apache.commons.collections4.Transformer<E,? extends Number> nev)
Creates an instance of
DijkstraShortestPath for
the specified graph and the specified method of extracting weights
from edges, which caches results locally. |
DijkstraShortestPath(Graph<V,E> g,
org.apache.commons.collections4.Transformer<E,? extends Number> nev,
boolean cached)
Creates an instance of
DijkstraShortestPath for
the specified graph and the specified method of extracting weights
from edges, which caches results locally if and only if
cached is true . |
MinimumSpanningForest(Graph<V,E> graph,
org.apache.commons.collections4.Factory<Forest<V,E>> factory,
V root,
Map<E,Double> weights)
Creates a Forest from the supplied Graph and supplied Factory, which
is used to create a new, empty Forest.
|
MinimumSpanningForest(Graph<V,E> graph,
Forest<V,E> forest,
V root)
Creates a minimum spanning forest from the supplied graph, populating the
supplied Forest, which must be empty.
|
MinimumSpanningForest(Graph<V,E> graph,
Forest<V,E> forest,
V root,
Map<E,Double> weights)
Creates a minimum spanning forest from the supplied graph, populating the
supplied Forest, which must be empty.
|
MinimumSpanningForest2(Graph<V,E> graph,
org.apache.commons.collections4.Factory<Forest<V,E>> factory,
org.apache.commons.collections4.Factory<? extends Graph<V,E>> treeFactory,
org.apache.commons.collections4.Transformer<E,Double> weights)
create a Forest from the supplied Graph and supplied Factory, which
is used to create a new, empty Forest.
|
MinimumSpanningForest2(Graph<V,E> graph,
Forest<V,E> forest,
org.apache.commons.collections4.Factory<? extends Graph<V,E>> treeFactory,
org.apache.commons.collections4.Transformer<E,Double> weights)
create a forest from the supplied graph, populating the
supplied Forest, which must be empty.
|
Constructor and Description |
---|
MinimumSpanningForest2(Graph<V,E> graph,
org.apache.commons.collections4.Factory<Forest<V,E>> factory,
org.apache.commons.collections4.Factory<? extends Graph<V,E>> treeFactory,
org.apache.commons.collections4.Transformer<E,Double> weights)
create a Forest from the supplied Graph and supplied Factory, which
is used to create a new, empty Forest.
|
MinimumSpanningForest2(Graph<V,E> graph,
Forest<V,E> forest,
org.apache.commons.collections4.Factory<? extends Graph<V,E>> treeFactory,
org.apache.commons.collections4.Transformer<E,Double> weights)
create a forest from the supplied graph, populating the
supplied Forest, which must be empty.
|
PrimMinimumSpanningTree(org.apache.commons.collections4.Factory<? extends Graph<V,E>> factory)
Creates an instance which generates a minimum spanning tree assuming constant edge weights.
|
PrimMinimumSpanningTree(org.apache.commons.collections4.Factory<? extends Graph<V,E>> factory,
org.apache.commons.collections4.Transformer<E,Double> weights)
Creates an instance which generates a minimum spanning tree using the input edge weights.
|
Modifier and Type | Field and Description |
---|---|
protected org.apache.commons.collections4.Factory<Graph<CV,CE>> |
VertexPartitionCollapser.graph_factory |
Modifier and Type | Method and Description |
---|---|
Graph<CV,CE> |
VertexPartitionCollapser.collapseVertexPartitions(VertexPartition<V,E> partitioning)
Creates a new graph whose vertices correspond to the partitions of the supplied graph.
|
static <V,E> Graph<V,Collection<E>> |
FoldingTransformer.foldHypergraphEdges(Hypergraph<V,E> h,
org.apache.commons.collections4.Factory<Graph<V,Collection<E>>> graph_factory)
Creates a
Graph which is an edge-folded version of h , where
hyperedges are replaced by k-cliques in the output graph. |
static <V,E> Graph<V,E> |
FoldingTransformer.foldHypergraphEdges(Hypergraph<V,E> h,
org.apache.commons.collections4.Factory<Graph<V,E>> graph_factory,
org.apache.commons.collections4.Factory<E> edge_factory)
Creates a
Graph which is an edge-folded version of h , where
hyperedges are replaced by k-cliques in the output graph. |
Graph<E,Collection<V>> |
FoldingTransformer.foldHypergraphVertices(Hypergraph<V,E> h,
org.apache.commons.collections4.Factory<Graph<E,Collection<V>>> graph_factory)
Creates a
Graph which is a vertex-folded version of h , whose
vertices are the input's hyperedges and whose edges are induced by adjacent hyperedges
in the input. |
static <V,E,F> Graph<E,F> |
FoldingTransformer.foldHypergraphVertices(Hypergraph<V,E> h,
org.apache.commons.collections4.Factory<Graph<E,F>> graph_factory,
org.apache.commons.collections4.Factory<F> edge_factory)
Creates a
Graph which is a vertex-folded version of h , whose
vertices are the input's hyperedges and whose edges are induced by adjacent hyperedges
in the input. |
static <V,E> Graph<V,Collection<V>> |
FoldingTransformer.foldKPartiteGraph(KPartiteGraph<V,E> g,
org.apache.commons.collections4.Predicate<V> p,
org.apache.commons.collections4.Factory<Graph<V,Collection<V>>> graph_factory)
Converts
g into a unipartite graph whose vertices are the
vertices of g 's partition p , and whose edges
consist of collections of the intermediate vertices from other partitions. |
static <V,E> Graph<V,E> |
FoldingTransformer.foldKPartiteGraph(KPartiteGraph<V,E> g,
org.apache.commons.collections4.Predicate<V> p,
org.apache.commons.collections4.Factory<Graph<V,E>> graph_factory,
org.apache.commons.collections4.Factory<E> edge_factory)
Converts
g into a unipartite graph whose vertex set is the
vertices of g 's partition p . |
static <V,E> Graph<V,E> |
DirectionTransformer.toDirected(Graph<V,E> graph,
org.apache.commons.collections4.Factory<DirectedGraph<V,E>> graph_factory,
org.apache.commons.collections4.Factory<E> edge_factory,
boolean create_new)
Transforms
graph (which may be of any directionality)
into a directed graph. |
Modifier and Type | Method and Description |
---|---|
static <V,E> Graph<V,E> |
DirectionTransformer.toDirected(Graph<V,E> graph,
org.apache.commons.collections4.Factory<DirectedGraph<V,E>> graph_factory,
org.apache.commons.collections4.Factory<E> edge_factory,
boolean create_new)
Transforms
graph (which may be of any directionality)
into a directed graph. |
static <V,E> UndirectedGraph<V,E> |
DirectionTransformer.toUndirected(Graph<V,E> graph,
org.apache.commons.collections4.Factory<UndirectedGraph<V,E>> graph_factory,
org.apache.commons.collections4.Factory<E> edge_factory,
boolean create_new)
Transforms
graph (which may be of any directionality)
into an undirected graph. |
Modifier and Type | Method and Description |
---|---|
static <V,E> Graph<V,Collection<E>> |
FoldingTransformer.foldHypergraphEdges(Hypergraph<V,E> h,
org.apache.commons.collections4.Factory<Graph<V,Collection<E>>> graph_factory)
Creates a
Graph which is an edge-folded version of h , where
hyperedges are replaced by k-cliques in the output graph. |
static <V,E> Graph<V,E> |
FoldingTransformer.foldHypergraphEdges(Hypergraph<V,E> h,
org.apache.commons.collections4.Factory<Graph<V,E>> graph_factory,
org.apache.commons.collections4.Factory<E> edge_factory)
Creates a
Graph which is an edge-folded version of h , where
hyperedges are replaced by k-cliques in the output graph. |
Graph<E,Collection<V>> |
FoldingTransformer.foldHypergraphVertices(Hypergraph<V,E> h,
org.apache.commons.collections4.Factory<Graph<E,Collection<V>>> graph_factory)
Creates a
Graph which is a vertex-folded version of h , whose
vertices are the input's hyperedges and whose edges are induced by adjacent hyperedges
in the input. |
static <V,E,F> Graph<E,F> |
FoldingTransformer.foldHypergraphVertices(Hypergraph<V,E> h,
org.apache.commons.collections4.Factory<Graph<E,F>> graph_factory,
org.apache.commons.collections4.Factory<F> edge_factory)
Creates a
Graph which is a vertex-folded version of h , whose
vertices are the input's hyperedges and whose edges are induced by adjacent hyperedges
in the input. |
static <V,E> Graph<V,Collection<V>> |
FoldingTransformer.foldKPartiteGraph(KPartiteGraph<V,E> g,
org.apache.commons.collections4.Predicate<V> p,
org.apache.commons.collections4.Factory<Graph<V,Collection<V>>> graph_factory)
Converts
g into a unipartite graph whose vertices are the
vertices of g 's partition p , and whose edges
consist of collections of the intermediate vertices from other partitions. |
static <V,E> Graph<V,E> |
FoldingTransformer.foldKPartiteGraph(KPartiteGraph<V,E> g,
org.apache.commons.collections4.Predicate<V> p,
org.apache.commons.collections4.Factory<Graph<V,E>> graph_factory,
org.apache.commons.collections4.Factory<E> edge_factory)
Converts
g into a unipartite graph whose vertex set is the
vertices of g 's partition p . |
Constructor and Description |
---|
VertexPartitionCollapser(org.apache.commons.collections4.Factory<Graph<CV,CE>> graph_factory,
org.apache.commons.collections4.Factory<CV> vertex_factory,
org.apache.commons.collections4.Factory<CE> edge_factory)
Creates an instance with the specified graph and element factories.
|
Modifier and Type | Method and Description |
---|---|
boolean |
SelfLoopEdgePredicate.evaluate(Context<Graph<V,E>,E> context) |
Modifier and Type | Interface and Description |
---|---|
interface |
DirectedGraph<V,E>
A tagging interface for implementations of
Graph
that accept only directed edges. |
interface |
Forest<V,E>
An interface for a graph which consists of a collection of rooted
directed acyclic graphs.
|
interface |
KPartiteGraph<V,E>
An interface for graphs whose vertices are each members of one of 2 or more
disjoint sets (partitions), and whose edges connect only vertices in distinct
partitions.
|
interface |
Tree<V,E>
A subtype of
Graph which is a (directed, rooted) tree. |
interface |
UndirectedGraph<V,E>
A tagging interface for extensions of
Graph that
accept only undirected edges. |
Modifier and Type | Class and Description |
---|---|
class |
AbstractGraph<V,E>
Abstract implementation of the
Graph interface. |
class |
AbstractTypedGraph<V,E>
An abstract class for graphs whose edges all have the same
EdgeType . |
class |
DelegateForest<V,E>
An implementation of
Forest that delegates to a specified DirectedGraph
instance. |
class |
DelegateTree<V,E>
An implementation of
Tree that delegates to
a specified instance of DirectedGraph . |
class |
DirectedOrderedSparseMultigraph<V,E>
An implementation of
DirectedGraph , suitable for sparse graphs,
that orders its vertex and edge collections
according to insertion time. |
class |
DirectedSparseGraph<V,E>
An implementation of
DirectedGraph suitable for sparse graphs. |
class |
DirectedSparseMultigraph<V,E>
An implementation of
DirectedGraph , suitable for sparse graphs,
that permits parallel edges. |
class |
GraphDecorator<V,E>
An implementation of
Graph that delegates its method calls to a
constructor-specified Graph instance. |
class |
ObservableGraph<V,E>
A decorator class for graphs which generates events
|
class |
OrderedKAryTree<V,E>
An implementation of
Tree in which each vertex has
<= k children. |
class |
OrderedSparseMultigraph<V,E>
An implementation of
Graph that orders its vertex and edge collections
according to insertion time, is suitable for sparse graphs, and
permits directed, undirected, and parallel edges. |
class |
SortedSparseMultigraph<V,E>
An implementation of
Graph that is suitable for sparse graphs,
orders its vertex and edge collections according to either specified Comparator
instances or the natural ordering of their elements, and permits directed, undirected,
and parallel edges. |
class |
SparseGraph<V,E>
An implementation of
Graph that is suitable for sparse graphs and
permits both directed and undirected edges. |
class |
SparseMultigraph<V,E>
An implementation of
Graph that is suitable for sparse graphs
and permits directed, undirected, and parallel edges. |
class |
UndirectedOrderedSparseMultigraph<V,E>
An implementation of
UndirectedGraph that is suitable for sparse graphs,
orders its vertex and edge collections according to insertion time, and permits
parallel edges. |
class |
UndirectedSparseGraph<V,E>
An implementation of
UndirectedGraph that is suitable
for sparse graphs. |
class |
UndirectedSparseMultigraph<V,E>
An implementation of
UndirectedGraph that is suitable for
sparse graphs and permits parallel edges. |
Modifier and Type | Field and Description |
---|---|
protected Graph<V,E> |
GraphDecorator.delegate |
Modifier and Type | Method and Description |
---|---|
static <V,E> org.apache.commons.collections4.Factory<Graph<V,E>> |
SortedSparseMultigraph.getFactory()
Returns a
Factory that creates an instance of this graph type. |
static <V,E> org.apache.commons.collections4.Factory<Graph<V,E>> |
OrderedSparseMultigraph.getFactory()
Returns a
Factory that creates an instance of this graph type. |
static <V,E> org.apache.commons.collections4.Factory<Graph<V,E>> |
SparseMultigraph.getFactory()
Returns a
Factory that creates an instance of this graph type. |
static <V,E> org.apache.commons.collections4.Factory<Graph<V,E>> |
SparseGraph.getFactory()
Returns a
Factory that creates an instance of this graph type. |
Constructor and Description |
---|
GraphDecorator(Graph<V,E> delegate)
Creates a new instance based on the provided
delegate . |
ObservableGraph(Graph<V,E> delegate)
Creates a new instance based on the provided
delegate . |
Modifier and Type | Field and Description |
---|---|
protected Graph<V,E> |
GraphEvent.source |
Modifier and Type | Method and Description |
---|---|
Graph<V,E> |
GraphEvent.getSource() |
Constructor and Description |
---|
Edge(Graph<V,E> source,
GraphEvent.Type type,
E edge)
Creates a graph event for the specified graph, edge, and type.
|
GraphEvent(Graph<V,E> source,
GraphEvent.Type type)
Creates an instance with the specified
source graph and Type
(vertex/edge addition/removal). |
Vertex(Graph<V,E> source,
GraphEvent.Type type,
V vertex)
Creates a graph event for the specified graph, vertex, and type.
|
Modifier and Type | Field and Description |
---|---|
protected Map<Context<Graph<V,E>,E>,Integer> |
DefaultParallelEdgeIndexFunction.edge_index |
Modifier and Type | Method and Description |
---|---|
static Graph<String,Number> |
TestGraphs.createChainPlusIsolates(int chain_length,
int isolate_count)
Returns a graph consisting of a chain of
vertex_count - 1 vertices
plus one isolated vertex. |
static Graph<String,Number> |
TestGraphs.createDirectedAcyclicGraph(int layers,
int maxNodesPerLayer,
double linkprob)
Creates a sample directed acyclic graph by generating several "layers",
and connecting nodes (randomly) to nodes in earlier (but never later)
layers.
|
static Graph<String,Number> |
TestGraphs.createTestGraph(boolean directed)
Creates a small sample graph that can be used for testing purposes.
|
static Graph<String,Number> |
TestGraphs.getDemoGraph()
Returns a bigger test graph with a clique, several components, and other
parts.
|
static Graph<String,Number> |
TestGraphs.getOneComponentGraph()
Returns a bigger, undirected test graph with a just one component.
|
static Graph<String,Number> |
TestGraphs.getSmallGraph()
Returns a small graph with directed and undirected edges, and parallel edges.
|
static <V,E> Graph<V,E> |
Graphs.synchronizedGraph(Graph<V,E> graph)
Returns a synchronized graph backed by the passed argument graph.
|
static <V,E> Graph<V,E> |
Graphs.unmodifiableGraph(Graph<V,E> graph)
Returns an unmodifiable Graph backed by the passed Graph.
|
Modifier and Type | Method and Description |
---|---|
int |
EdgeIndexFunction.getIndex(Graph<V,E> graph,
E e)
Returns
e 's index in graph . |
int |
DefaultParallelEdgeIndexFunction.getIndex(Graph<V,E> graph,
E e)
Returns the index for
e in graph . |
int |
IncidentEdgeIndexFunction.getIndex(Graph<V,E> graph,
E e)
Returns the index for the specified edge.
|
protected int |
DefaultParallelEdgeIndexFunction.getIndex(Graph<V,E> graph,
E e,
V v) |
protected int |
IncidentEdgeIndexFunction.getIndex(Graph<V,E> graph,
E e,
V v) |
protected int |
DefaultParallelEdgeIndexFunction.getIndex(Graph<V,E> graph,
E e,
V v,
V u) |
protected int |
IncidentEdgeIndexFunction.getIndex(Graph<V,E> graph,
E e,
V u,
V v) |
void |
EdgeIndexFunction.reset(Graph<V,E> g,
E edge)
Resets the indices for
edge and its parallel edges in graph . |
void |
DefaultParallelEdgeIndexFunction.reset(Graph<V,E> graph,
E e)
Resets the indices for this edge and its parallel edges.
|
void |
IncidentEdgeIndexFunction.reset(Graph<V,E> graph,
E e)
Resets the indices for this edge and its parallel edges.
|
static <V,E> Graph<V,E> |
Graphs.synchronizedGraph(Graph<V,E> graph)
Returns a synchronized graph backed by the passed argument graph.
|
static <V,E> Graph<V,E> |
Graphs.unmodifiableGraph(Graph<V,E> graph)
Returns an unmodifiable Graph backed by the passed Graph.
|
Modifier and Type | Class and Description |
---|---|
class |
PajekNetReader<G extends Graph<V,E>,V,E>
Reads a
Graph from a Pajek NET formatted source. |
Modifier and Type | Method and Description |
---|---|
Graph<V,E> |
GraphFile.load(String filename)
Loads a graph from a file per the appropriate format
|
Modifier and Type | Method and Description |
---|---|
protected E |
PajekNetReader.createAddEdge(StringTokenizer st,
V v1,
EdgeType directed,
Graph<V,E> g,
List<V> id,
org.apache.commons.collections4.Factory<E> edge_factory) |
void |
GraphFile.save(Graph<V,E> graph,
String filename)
Save a graph to disk per the appropriate format
|
void |
PajekNetWriter.save(Graph<V,E> g,
String filename)
Saves
g to filename ; no vertex labels are written out,
and the edge weights are written as 1.0. |
void |
PajekNetWriter.save(Graph<V,E> g,
String filename,
org.apache.commons.collections4.Transformer<V,String> vs,
org.apache.commons.collections4.Transformer<E,Number> nev)
Saves
g to filename . |
void |
PajekNetWriter.save(Graph<V,E> g,
String filename,
org.apache.commons.collections4.Transformer<V,String> vs,
org.apache.commons.collections4.Transformer<E,Number> nev,
org.apache.commons.collections4.Transformer<V,Point2D> vld)
Saves
g to filename . |
void |
PajekNetWriter.save(Graph<V,E> g,
Writer w)
Saves
g to w ; no vertex labels are written out,
and the edge weights are written as 1.0. |
void |
PajekNetWriter.save(Graph<V,E> g,
Writer w,
org.apache.commons.collections4.Transformer<V,String> vs,
org.apache.commons.collections4.Transformer<E,Number> nev)
Saves
g to w ; vertex labels are given by
vs and edge weights by nev . |
void |
PajekNetWriter.save(Graph<V,E> graph,
Writer w,
org.apache.commons.collections4.Transformer<V,String> vs,
org.apache.commons.collections4.Transformer<E,Number> nev,
org.apache.commons.collections4.Transformer<V,Point2D> vld)
Writes
graph to w . |
Modifier and Type | Field and Description |
---|---|
protected static Graph<? extends Object,? extends Object>[] |
ShowLayouts.g_array |
Modifier and Type | Field and Description |
---|---|
protected org.apache.commons.collections4.Predicate<Context<Graph<Integer,Number>,Number>> |
PluggableRendererDemo.self_loop |
Modifier and Type | Method and Description |
---|---|
static Graph |
SimpleGraphDraw.getGraph()
Generates a graph: in this case, reads it from the file
"samples/datasetsgraph/simple.net"
|
Graph<Integer,Number> |
PluggableRendererDemo.getGraph()
Generates a mixed-mode random graph, runs VoltageRanker on it, and
returns the resultant graph.
|
Modifier and Type | Field and Description |
---|---|
protected org.apache.commons.collections4.Predicate<Context<Graph<V,E>,E>> |
PluggableRenderContext.edgeArrowPredicate |
protected org.apache.commons.collections4.Transformer<Context<Graph<V,E>,E>,Shape> |
PluggableRenderContext.edgeArrowTransformer |
protected org.apache.commons.collections4.Predicate<Context<Graph<V,E>,E>> |
PluggableRenderContext.edgeIncludePredicate |
protected org.apache.commons.collections4.Transformer<Context<Graph<V,E>,E>,Number> |
PluggableRenderContext.edgeLabelClosenessTransformer |
protected org.apache.commons.collections4.Transformer<Context<Graph<V,E>,E>,Shape> |
PluggableRenderContext.edgeShapeTransformer |
protected org.apache.commons.collections4.Predicate<Context<Graph<V,E>,V>> |
PluggableRenderContext.vertexIncludePredicate |
Modifier and Type | Method and Description |
---|---|
org.apache.commons.collections4.Predicate<Context<Graph<V,E>,E>> |
PluggableRenderContext.getEdgeArrowPredicate() |
org.apache.commons.collections4.Predicate<Context<Graph<V,E>,E>> |
RenderContext.getEdgeArrowPredicate() |
org.apache.commons.collections4.Transformer<Context<Graph<V,E>,E>,Shape> |
PluggableRenderContext.getEdgeArrowTransformer() |
org.apache.commons.collections4.Transformer<Context<Graph<V,E>,E>,Shape> |
RenderContext.getEdgeArrowTransformer() |
org.apache.commons.collections4.Predicate<Context<Graph<V,E>,E>> |
PluggableRenderContext.getEdgeIncludePredicate() |
org.apache.commons.collections4.Predicate<Context<Graph<V,E>,E>> |
RenderContext.getEdgeIncludePredicate() |
org.apache.commons.collections4.Transformer<Context<Graph<V,E>,E>,Number> |
PluggableRenderContext.getEdgeLabelClosenessTransformer() |
org.apache.commons.collections4.Transformer<Context<Graph<V,E>,E>,Number> |
RenderContext.getEdgeLabelClosenessTransformer() |
org.apache.commons.collections4.Transformer<Context<Graph<V,E>,E>,Shape> |
PluggableRenderContext.getEdgeShapeTransformer() |
org.apache.commons.collections4.Transformer<Context<Graph<V,E>,E>,Shape> |
RenderContext.getEdgeShapeTransformer() |
org.apache.commons.collections4.Predicate<Context<Graph<V,E>,V>> |
PluggableRenderContext.getVertexIncludePredicate() |
org.apache.commons.collections4.Predicate<Context<Graph<V,E>,V>> |
RenderContext.getVertexIncludePredicate() |
Modifier and Type | Method and Description |
---|---|
boolean |
RenderContext.DirectedEdgeArrowPredicate.evaluate(Context<Graph<V,E>,E> c) |
boolean |
RenderContext.UndirectedEdgeArrowPredicate.evaluate(Context<Graph<V,E>,E> c) |
void |
PluggableRenderContext.setEdgeArrowPredicate(org.apache.commons.collections4.Predicate<Context<Graph<V,E>,E>> edgeArrowPredicate) |
void |
RenderContext.setEdgeArrowPredicate(org.apache.commons.collections4.Predicate<Context<Graph<V,E>,E>> edgeArrowPredicate) |
void |
PluggableRenderContext.setEdgeArrowTransformer(org.apache.commons.collections4.Transformer<Context<Graph<V,E>,E>,Shape> edgeArrowTransformer) |
void |
RenderContext.setEdgeArrowTransformer(org.apache.commons.collections4.Transformer<Context<Graph<V,E>,E>,Shape> edgeArrowTransformer) |
void |
PluggableRenderContext.setEdgeIncludePredicate(org.apache.commons.collections4.Predicate<Context<Graph<V,E>,E>> edgeIncludePredicate) |
void |
RenderContext.setEdgeIncludePredicate(org.apache.commons.collections4.Predicate<Context<Graph<V,E>,E>> edgeIncludePredicate) |
void |
PluggableRenderContext.setEdgeLabelClosenessTransformer(org.apache.commons.collections4.Transformer<Context<Graph<V,E>,E>,Number> edgeLabelClosenessTransformer) |
void |
RenderContext.setEdgeLabelClosenessTransformer(org.apache.commons.collections4.Transformer<Context<Graph<V,E>,E>,Number> edgeLabelClosenessTransformer) |
void |
PluggableRenderContext.setEdgeShapeTransformer(org.apache.commons.collections4.Transformer<Context<Graph<V,E>,E>,Shape> edgeShapeTransformer) |
void |
RenderContext.setEdgeShapeTransformer(org.apache.commons.collections4.Transformer<Context<Graph<V,E>,E>,Shape> edgeShapeTransformer) |
void |
PluggableRenderContext.setVertexIncludePredicate(org.apache.commons.collections4.Predicate<Context<Graph<V,E>,V>> vertexIncludePredicate) |
void |
RenderContext.setVertexIncludePredicate(org.apache.commons.collections4.Predicate<Context<Graph<V,E>,V>> vertexIncludePredicate) |
Modifier and Type | Field and Description |
---|---|
protected org.apache.commons.collections4.Predicate<Context<Graph<V,E>,E>> |
GradientEdgePaintTransformer.selfLoop |
Modifier and Type | Method and Description |
---|---|
Shape |
EdgeShape.Line.transform(Context<Graph<V,E>,E> context)
Get the shape for this edge, returning either the
shared instance or, in the case of self-loop edges, the
SimpleLoop shared instance.
|
Shape |
EdgeShape.BentLine.transform(Context<Graph<V,E>,E> context)
Get the shape for this edge, returning either the
shared instance or, in the case of self-loop edges, the
Loop shared instance.
|
Shape |
EdgeShape.QuadCurve.transform(Context<Graph<V,E>,E> context)
Get the shape for this edge, returning either the
shared instance or, in the case of self-loop edges, the
Loop shared instance.
|
Shape |
EdgeShape.CubicCurve.transform(Context<Graph<V,E>,E> context)
Get the shape for this edge, returning either the
shared instance or, in the case of self-loop edges, the
Loop shared instance.
|
Shape |
EdgeShape.SimpleLoop.transform(Context<Graph<V,E>,E> context)
getter for the shape
|
Shape |
EdgeShape.Loop.transform(Context<Graph<V,E>,E> context)
Get the shape for this edge, modifying the diameter in the
case of parallel edges, so they do not overlap
|
Shape |
EdgeShape.Wedge.transform(Context<Graph<V,E>,E> context) |
Shape |
EdgeShape.Box.transform(Context<Graph<V,E>,E> context)
Get the shape for this edge, modifying the diameter in the
case of parallel edges, so they do not overlap
|
Shape |
EdgeShape.Orthogonal.transform(Context<Graph<V,E>,E> context)
Get the shape for this edge, returning either the
shared instance or, in the case of self-loop edges, the
Loop shared instance.
|
Shape |
DirectionalEdgeArrowTransformer.transform(Context<Graph<V,E>,E> context) |
Number |
ConstantDirectionalEdgeValueTransformer.transform(Context<Graph<V,E>,E> context) |
Modifier and Type | Field and Description |
---|---|
protected Graph<V,E> |
BoundingRectanglePaintable.graph |
protected Graph<V,E> |
BoundingRectangleCollector.graph |
Modifier and Type | Method and Description |
---|---|
void |
ObservableCachingLayout.setGraph(Graph<V,E> graph) |
void |
CachingLayout.setGraph(Graph<V,E> graph) |
Modifier and Type | Method and Description |
---|---|
protected boolean |
ShapePickSupport.isEdgeRendered(Context<Graph<V,E>,E> context)
Returns
true if this edge and its endpoints
in this graph are all included in the collections of
elements to be rendered, and false otherwise. |
protected boolean |
ShapePickSupport.isVertexRendered(Context<Graph<V,E>,V> context)
Returns
true if this vertex in this graph is included
in the collections of elements to be rendered, and false otherwise. |
Modifier and Type | Method and Description |
---|---|
Graph |
GraphCollapser.collapse(Graph inGraph,
Graph clusterGraph) |
Graph |
GraphCollapser.expand(Graph inGraph,
Graph clusterGraph) |
Graph |
GraphCollapser.getClusterGraph(Graph inGraph,
Collection picked) |
Modifier and Type | Method and Description |
---|---|
Graph |
GraphCollapser.collapse(Graph inGraph,
Graph clusterGraph) |
Graph |
GraphCollapser.collapse(Graph inGraph,
Graph clusterGraph) |
Graph |
GraphCollapser.expand(Graph inGraph,
Graph clusterGraph) |
Graph |
GraphCollapser.expand(Graph inGraph,
Graph clusterGraph) |
Graph |
GraphCollapser.getClusterGraph(Graph inGraph,
Collection picked) |
Constructor and Description |
---|
GraphCollapser(Graph originalGraph) |
Modifier and Type | Method and Description |
---|---|
int |
PredicatedParallelEdgeIndexFunction.getIndex(Graph<V,E> graph,
E e)
Returns the index for the specified edge.
|
protected int |
PredicatedParallelEdgeIndexFunction.getIndex(Graph<V,E> graph,
E e,
V v) |
protected int |
PredicatedParallelEdgeIndexFunction.getIndex(Graph<V,E> graph,
E e,
V v,
V u) |
void |
PredicatedParallelEdgeIndexFunction.reset(Graph<V,E> graph,
E e)
Resets the indices for this edge and its parallel edges.
|
Copyright © 2015. All rights reserved.