|
||||||||||
PREV NEXT | FRAMES NO FRAMES |
Packages that use Graph | |
---|---|
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.layout3d | |
edu.uci.ics.jung.algorithms.matrix | Mechanisms for dealing with graphs as matrices. |
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. |
edu.uci.ics.jung.visualization3d | |
edu.uci.ics.jung.visualization3d.layout |
Uses of Graph in edu.uci.ics.jung.algorithms.blockmodel |
---|
Methods in edu.uci.ics.jung.algorithms.blockmodel that return Graph | |
---|---|
Graph<V,E> |
VertexPartition.getGraph()
Returns the graph on which the partition is defined. |
Methods in edu.uci.ics.jung.algorithms.blockmodel with parameters of type Graph | |
---|---|
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)
|
Constructors in edu.uci.ics.jung.algorithms.blockmodel with parameters of type Graph | |
---|---|
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. |
Uses of Graph in edu.uci.ics.jung.algorithms.cluster |
---|
Fields in edu.uci.ics.jung.algorithms.cluster declared as Graph | |
---|---|
protected Graph<V,E> |
VoltageClusterer.g
|
Methods in edu.uci.ics.jung.algorithms.cluster with parameters of type Graph | |
---|---|
Set<Set<V>> |
WeakComponentClusterer.transform(Graph<V,E> graph)
Extracts the weak components from a graph. |
Set<Set<V>> |
EdgeBetweennessClusterer.transform(Graph<V,E> graph)
Finds the set of clusters which have the strongest "community structure". |
Constructors in edu.uci.ics.jung.algorithms.cluster with parameters of type Graph | |
---|---|
VoltageClusterer(Graph<V,E> g,
int num_candidates)
Creates an instance of a VoltageCluster with the specified parameters. |
Uses of Graph in edu.uci.ics.jung.algorithms.filters |
---|
Methods in edu.uci.ics.jung.algorithms.filters that return Graph | |
---|---|
Graph<V,E> |
VertexPredicateFilter.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). |
Graph<V,E> |
EdgePredicateFilter.transform(Graph<V,E> g)
|
Methods in edu.uci.ics.jung.algorithms.filters with parameters of type Graph | |
---|---|
Graph<V,E> |
VertexPredicateFilter.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). |
Graph<V,E> |
EdgePredicateFilter.transform(Graph<V,E> g)
|
Uses of Graph in edu.uci.ics.jung.algorithms.generators |
---|
Fields in edu.uci.ics.jung.algorithms.generators with type parameters of type Graph | |
---|---|
protected org.apache.commons.collections15.Factory<Graph<V,E>> |
Lattice2DGenerator.graph_factory
|
Methods in edu.uci.ics.jung.algorithms.generators that return Graph | |
---|---|
Graph<V,E> |
Lattice2DGenerator.create()
|
Constructor parameters in edu.uci.ics.jung.algorithms.generators with type arguments of type Graph | |
---|---|
Lattice2DGenerator(org.apache.commons.collections15.Factory<Graph<V,E>> graph_factory,
org.apache.commons.collections15.Factory<V> vertex_factory,
org.apache.commons.collections15.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.collections15.Factory<Graph<V,E>> graph_factory,
org.apache.commons.collections15.Factory<V> vertex_factory,
org.apache.commons.collections15.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. |
Uses of Graph in edu.uci.ics.jung.algorithms.generators.random |
---|
Fields in edu.uci.ics.jung.algorithms.generators.random with type parameters of type Graph | |
---|---|
protected org.apache.commons.collections15.Factory<Graph<V,E>> |
BarabasiAlbertGenerator.graphFactory
|
Methods in edu.uci.ics.jung.algorithms.generators.random that return Graph | ||
---|---|---|
Graph<V,E> |
KleinbergSmallWorldGenerator.create()
Generates a random small world network according to the parameters given |
|
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. |
|
Graph<V,E> |
EppsteinPowerLawGenerator.create()
Generates a graph whose degree distribution approximates a power-law. |
|
Graph<V,E> |
BarabasiAlbertGenerator.create()
|
|
static
|
MixedRandomGraphGenerator.generateMixedRandomGraph(org.apache.commons.collections15.Factory<Graph<V,E>> graphFactory,
org.apache.commons.collections15.Factory<V> vertexFactory,
org.apache.commons.collections15.Factory<E> edgeFactory,
Map<E,Number> edge_weights,
int num_vertices,
boolean parallel,
Set<V> seedVertices)
Returns a random mixed-mode graph. |
|
static
|
MixedRandomGraphGenerator.generateMixedRandomGraph(org.apache.commons.collections15.Factory<Graph<V,E>> graphFactory,
org.apache.commons.collections15.Factory<V> vertexFactory,
org.apache.commons.collections15.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()
|
Method parameters in edu.uci.ics.jung.algorithms.generators.random with type arguments of type Graph | ||
---|---|---|
static
|
MixedRandomGraphGenerator.generateMixedRandomGraph(org.apache.commons.collections15.Factory<Graph<V,E>> graphFactory,
org.apache.commons.collections15.Factory<V> vertexFactory,
org.apache.commons.collections15.Factory<E> edgeFactory,
Map<E,Number> edge_weights,
int num_vertices,
boolean parallel,
Set<V> seedVertices)
Returns a random mixed-mode graph. |
|
static
|
MixedRandomGraphGenerator.generateMixedRandomGraph(org.apache.commons.collections15.Factory<Graph<V,E>> graphFactory,
org.apache.commons.collections15.Factory<V> vertexFactory,
org.apache.commons.collections15.Factory<E> edgeFactory,
Map<E,Number> edge_weight,
int num_vertices,
Set<V> seedVertices)
Equivalent to generateMixedRandomGraph(edge_weight, num_vertices, true) . |
Constructor parameters in edu.uci.ics.jung.algorithms.generators.random with type arguments of type Graph | |
---|---|
BarabasiAlbertGenerator(org.apache.commons.collections15.Factory<Graph<V,E>> graphFactory,
org.apache.commons.collections15.Factory<V> vertexFactory,
org.apache.commons.collections15.Factory<E> edgeFactory,
int init_vertices,
int numEdgesToAttach,
int seed,
Set<V> seedVertices)
Constructs a new instance of the generator. |
|
BarabasiAlbertGenerator(org.apache.commons.collections15.Factory<Graph<V,E>> graphFactory,
org.apache.commons.collections15.Factory<V> vertexFactory,
org.apache.commons.collections15.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.collections15.Factory<Graph<V,E>> graphFactory,
org.apache.commons.collections15.Factory<V> vertexFactory,
org.apache.commons.collections15.Factory<E> edgeFactory,
int numVertices,
int numEdges,
int r)
Creates an instance with the specified factories and specifications. |
|
KleinbergSmallWorldGenerator(org.apache.commons.collections15.Factory<Graph<V,E>> graph_factory,
org.apache.commons.collections15.Factory<V> vertex_factory,
org.apache.commons.collections15.Factory<E> edge_factory,
int latticeSize,
double clusteringExponent)
Creates |
|
KleinbergSmallWorldGenerator(org.apache.commons.collections15.Factory<Graph<V,E>> graph_factory,
org.apache.commons.collections15.Factory<V> vertex_factory,
org.apache.commons.collections15.Factory<E> edge_factory,
int row_count,
int col_count,
double clusteringExponent)
|
|
KleinbergSmallWorldGenerator(org.apache.commons.collections15.Factory<Graph<V,E>> graph_factory,
org.apache.commons.collections15.Factory<V> vertex_factory,
org.apache.commons.collections15.Factory<E> edge_factory,
int row_count,
int col_count,
double clusteringExponent,
boolean isToroidal)
|
Uses of Graph in edu.uci.ics.jung.algorithms.importance |
---|
Methods in edu.uci.ics.jung.algorithms.importance that return Graph | |
---|---|
protected Graph<V,E> |
AbstractRanker.getGraph()
|
Methods in edu.uci.ics.jung.algorithms.importance with parameters of type Graph | |
---|---|
protected void |
BetweennessCentrality.computeBetweenness(Graph<V,E> graph)
|
protected void |
AbstractRanker.initialize(Graph<V,E> graph,
boolean isNodeRanker,
boolean isEdgeRanker)
|
Constructors in edu.uci.ics.jung.algorithms.importance with parameters of type Graph | |
---|---|
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)
|
Uses of Graph in edu.uci.ics.jung.algorithms.layout |
---|
Fields in edu.uci.ics.jung.algorithms.layout declared as Graph | |
---|---|
protected Graph<V,E> |
AbstractLayout.graph
|
Methods in edu.uci.ics.jung.algorithms.layout that return Graph | |
---|---|
Graph<V,E> |
TreeLayout.getGraph()
|
Graph<V,E> |
LayoutDecorator.getGraph()
|
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> |
AbstractLayout.getGraph()
Accessor for the graph that represets all vertices. |
Methods in edu.uci.ics.jung.algorithms.layout with parameters of type Graph | |
---|---|
void |
TreeLayout.setGraph(Graph<V,E> graph)
|
void |
LayoutDecorator.setGraph(Graph<V,E> graph)
|
void |
Layout.setGraph(Graph<V,E> graph)
setter for graph |
void |
AggregateLayout.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. |
Constructors in edu.uci.ics.jung.algorithms.layout with parameters of type Graph | |
---|---|
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.collections15.Transformer<V,Point2D> initializer)
|
|
AbstractLayout(Graph<V,E> graph,
org.apache.commons.collections15.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.collections15.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.collections15.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.collections15.Transformer<V,Point2D> initializer)
Creates an instance for the specified graph and locations, with default size. |
|
StaticLayout(Graph<V,E> graph,
org.apache.commons.collections15.Transformer<V,Point2D> initializer,
Dimension size)
Creates an instance for the specified graph, locations, and size. |
Uses of Graph in edu.uci.ics.jung.algorithms.layout3d |
---|
Methods in edu.uci.ics.jung.algorithms.layout3d that return Graph | |
---|---|
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> |
AbstractLayout.getGraph()
Accessor for the graph that represets all vertices. |
Methods in edu.uci.ics.jung.algorithms.layout3d with parameters of type Graph | |
---|---|
void |
Layout.setGraph(Graph<V,E> graph)
setter for graph |
void |
AbstractLayout.setGraph(Graph<V,E> graph)
|
Constructors in edu.uci.ics.jung.algorithms.layout3d with parameters of type Graph | |
---|---|
AbstractLayout(Graph<V,E> graph)
Constructor. |
|
AbstractLayout(Graph<V,E> graph,
javax.media.j3d.BoundingSphere size)
|
|
AbstractLayout(Graph<V,E> graph,
org.apache.commons.collections15.Transformer<V,javax.vecmath.Point3f> initializer)
|
|
AbstractLayout(Graph<V,E> graph,
org.apache.commons.collections15.Transformer<V,javax.vecmath.Point3f> initializer,
javax.media.j3d.BoundingSphere size)
|
|
FRLayout(Graph<V,E> g)
|
|
FRLayout(Graph<V,E> g,
javax.media.j3d.BoundingSphere d)
|
|
ISOMLayout(Graph<V,E> g)
|
|
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,
SpringLayout.LengthFunction<E> f)
Constructor for a SpringLayout for a raw graph with associated component. |
Uses of Graph in edu.uci.ics.jung.algorithms.matrix |
---|
Methods in edu.uci.ics.jung.algorithms.matrix that return Graph | ||
---|---|---|
static
|
GraphMatrixOperations.matrixToGraph(cern.colt.matrix.DoubleMatrix2D matrix,
org.apache.commons.collections15.Factory<? extends Graph<V,E>> graphFactory,
org.apache.commons.collections15.Factory<V> vertexFactory,
org.apache.commons.collections15.Factory<E> edgeFactory)
Creates a graph from a square (weighted) adjacency matrix. |
|
static
|
GraphMatrixOperations.matrixToGraph(cern.colt.matrix.DoubleMatrix2D matrix,
org.apache.commons.collections15.Factory<? extends Graph<V,E>> graphFactory,
org.apache.commons.collections15.Factory<V> vertexFactory,
org.apache.commons.collections15.Factory<E> edgeFactory,
Map<E,Number> nev)
Creates a graph from a square (weighted) adjacency matrix. |
|
static
|
GraphMatrixOperations.square(Graph<V,E> g,
org.apache.commons.collections15.Factory<E> edgeFactory,
MatrixElementOperations<E> meo)
Returns the graph that corresponds to the square of the (weighted) adjacency matrix that the specified graph g encodes. |
Methods in edu.uci.ics.jung.algorithms.matrix with parameters of type Graph | ||
---|---|---|
static
|
GraphMatrixOperations.computeMeanFirstPassageMatrix(Graph<V,E> G,
Map<E,Number> edgeWeights,
cern.colt.matrix.DoubleMatrix1D stationaryDistribution)
Computes the all-pairs mean first passage time for the specified graph, given an existing stationary probability distribution. |
|
static
|
GraphMatrixOperations.createVertexDegreeDiagonalMatrix(Graph<V,E> graph)
Returns a diagonal matrix whose diagonal entries contain the degree for the corresponding node. |
|
static
|
GraphMatrixOperations.graphToSparseMatrix(Graph<V,E> g)
Returns an unweighted (0-1) adjacency matrix based on the specified graph. |
|
static
|
GraphMatrixOperations.graphToSparseMatrix(Graph<V,E> g,
Map<E,Number> nev)
Returns a SparseDoubleMatrix2D whose entries represent the edge weights for the edges in g , as specified by nev . |
|
static
|
GraphMatrixOperations.square(Graph<V,E> g,
org.apache.commons.collections15.Factory<E> edgeFactory,
MatrixElementOperations<E> meo)
Returns the graph that corresponds to the square of the (weighted) adjacency matrix that the specified graph g encodes. |
Method parameters in edu.uci.ics.jung.algorithms.matrix with type arguments of type Graph | ||
---|---|---|
static
|
GraphMatrixOperations.matrixToGraph(cern.colt.matrix.DoubleMatrix2D matrix,
org.apache.commons.collections15.Factory<? extends Graph<V,E>> graphFactory,
org.apache.commons.collections15.Factory<V> vertexFactory,
org.apache.commons.collections15.Factory<E> edgeFactory)
Creates a graph from a square (weighted) adjacency matrix. |
|
static
|
GraphMatrixOperations.matrixToGraph(cern.colt.matrix.DoubleMatrix2D matrix,
org.apache.commons.collections15.Factory<? extends Graph<V,E>> graphFactory,
org.apache.commons.collections15.Factory<V> vertexFactory,
org.apache.commons.collections15.Factory<E> edgeFactory,
Map<E,Number> nev)
Creates a graph from a square (weighted) adjacency matrix. |
Uses of Graph in edu.uci.ics.jung.algorithms.metrics |
---|
Fields in edu.uci.ics.jung.algorithms.metrics declared as Graph | |
---|---|
protected Graph<V,E> |
StructuralHoles.g
|
Methods in edu.uci.ics.jung.algorithms.metrics with parameters of type Graph | ||
---|---|---|
static
|
Metrics.clusteringCoefficients(Graph<V,E> graph)
Returns a Map of vertices to their clustering coefficients. |
|
protected static
|
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
|
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
|
TriadicCensus.triCode(Graph<V,E> g,
V u,
V v,
V w)
This is the core of the technique in the paper. |
Constructors in edu.uci.ics.jung.algorithms.metrics with parameters of type Graph | |
---|---|
StructuralHoles(Graph<V,E> graph,
org.apache.commons.collections15.Transformer<E,? extends Number> nev)
Creates a StructuralHoles instance based on the
edge weights specified by nev . |
Uses of Graph in edu.uci.ics.jung.algorithms.scoring |
---|
Fields in edu.uci.ics.jung.algorithms.scoring declared as Graph | |
---|---|
protected Graph<V,E> |
BetweennessCentrality.graph
|
Methods in edu.uci.ics.jung.algorithms.scoring with parameters of type Graph | |
---|---|
protected void |
BetweennessCentrality.initialize(Graph<V,E> graph)
|
Constructors in edu.uci.ics.jung.algorithms.scoring with parameters of type Graph | |
---|---|
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.collections15.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.collections15.Transformer<E,Double> edge_weights,
double alpha)
Creates an instance for the specified graph, edge weights, and alpha (random jump probability) parameter. |
Uses of Graph in edu.uci.ics.jung.algorithms.scoring.util |
---|
Fields in edu.uci.ics.jung.algorithms.scoring.util declared as Graph | |
---|---|
protected Graph<V,E> |
UniformInOut.graph
The graph for which the edge weights are defined. |
Constructors in edu.uci.ics.jung.algorithms.scoring.util with parameters of type Graph | |
---|---|
UniformInOut(Graph<V,E> graph)
Creates an instance for the specified graph. |
Uses of Graph in edu.uci.ics.jung.algorithms.shortestpath |
---|
Fields in edu.uci.ics.jung.algorithms.shortestpath declared as Graph | |
---|---|
protected Graph<V,E> |
MinimumSpanningForest2.graph
|
protected Graph<V,E> |
MinimumSpanningForest.graph
|
Fields in edu.uci.ics.jung.algorithms.shortestpath with type parameters of type Graph | |
---|---|
protected org.apache.commons.collections15.Factory<? extends Graph<V,E>> |
PrimMinimumSpanningTree.treeFactory
|
Methods in edu.uci.ics.jung.algorithms.shortestpath that return Graph | |
---|---|
Graph<V,E> |
PrimMinimumSpanningTree.transform(Graph<V,E> graph)
|
Methods in edu.uci.ics.jung.algorithms.shortestpath with parameters of type Graph | ||
---|---|---|
protected V |
PrimMinimumSpanningTree.findRoot(Graph<V,E> graph)
|
|
static
|
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)
|
Constructors in edu.uci.ics.jung.algorithms.shortestpath with parameters of type Graph | |
---|---|
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.collections15.Transformer<E,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.collections15.Transformer<E,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.collections15.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.collections15.Factory<Forest<V,E>> factory,
org.apache.commons.collections15.Factory<? extends Graph<V,E>> treeFactory,
org.apache.commons.collections15.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.collections15.Factory<? extends Graph<V,E>> treeFactory,
org.apache.commons.collections15.Transformer<E,Double> weights)
create a forest from the supplied graph, populating the supplied Forest, which must be empty. |
Constructor parameters in edu.uci.ics.jung.algorithms.shortestpath with type arguments of type Graph | |
---|---|
MinimumSpanningForest2(Graph<V,E> graph,
org.apache.commons.collections15.Factory<Forest<V,E>> factory,
org.apache.commons.collections15.Factory<? extends Graph<V,E>> treeFactory,
org.apache.commons.collections15.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.collections15.Factory<? extends Graph<V,E>> treeFactory,
org.apache.commons.collections15.Transformer<E,Double> weights)
create a forest from the supplied graph, populating the supplied Forest, which must be empty. |
|
PrimMinimumSpanningTree(org.apache.commons.collections15.Factory<? extends Graph<V,E>> factory)
Creates an instance which generates a minimum spanning tree assuming constant edge weights. |
|
PrimMinimumSpanningTree(org.apache.commons.collections15.Factory<? extends Graph<V,E>> factory,
org.apache.commons.collections15.Transformer<E,Double> weights)
Creates an instance which generates a minimum spanning tree using the input edge weights. |
Uses of Graph in edu.uci.ics.jung.algorithms.transformation |
---|
Fields in edu.uci.ics.jung.algorithms.transformation with type parameters of type Graph | |
---|---|
protected org.apache.commons.collections15.Factory<Graph<CV,CE>> |
VertexPartitionCollapser.graph_factory
|
Methods in edu.uci.ics.jung.algorithms.transformation that return Graph | ||
---|---|---|
Graph<CV,CE> |
VertexPartitionCollapser.collapseVertexPartitions(VertexPartition<V,E> partitioning)
Creates a new graph whose vertices correspond to the partitions of the supplied graph. |
|
static
|
FoldingTransformer.foldHypergraphEdges(Hypergraph<V,E> h,
org.apache.commons.collections15.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
|
FoldingTransformer.foldHypergraphEdges(Hypergraph<V,E> h,
org.apache.commons.collections15.Factory<Graph<V,E>> graph_factory,
org.apache.commons.collections15.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.collections15.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
|
FoldingTransformer.foldHypergraphVertices(Hypergraph<V,E> h,
org.apache.commons.collections15.Factory<Graph<E,F>> graph_factory,
org.apache.commons.collections15.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
|
FoldingTransformer.foldKPartiteGraph(KPartiteGraph<V,E> g,
org.apache.commons.collections15.Predicate<V> p,
org.apache.commons.collections15.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
|
FoldingTransformer.foldKPartiteGraph(KPartiteGraph<V,E> g,
org.apache.commons.collections15.Predicate<V> p,
org.apache.commons.collections15.Factory<Graph<V,E>> graph_factory,
org.apache.commons.collections15.Factory<E> edge_factory)
Converts g into a unipartite graph whose vertex set is the
vertices of g 's partition p . |
|
static
|
DirectionTransformer.toDirected(Graph<V,E> graph,
org.apache.commons.collections15.Factory<DirectedGraph<V,E>> graph_factory,
org.apache.commons.collections15.Factory<E> edge_factory,
boolean create_new)
Transforms graph (which may be of any directionality)
into a directed graph. |
Methods in edu.uci.ics.jung.algorithms.transformation with parameters of type Graph | ||
---|---|---|
static
|
DirectionTransformer.toDirected(Graph<V,E> graph,
org.apache.commons.collections15.Factory<DirectedGraph<V,E>> graph_factory,
org.apache.commons.collections15.Factory<E> edge_factory,
boolean create_new)
Transforms graph (which may be of any directionality)
into a directed graph. |
|
static
|
DirectionTransformer.toUndirected(Graph<V,E> graph,
org.apache.commons.collections15.Factory<UndirectedGraph<V,E>> graph_factory,
org.apache.commons.collections15.Factory<E> edge_factory,
boolean create_new)
Transforms graph (which may be of any directionality)
into an undirected graph. |
Method parameters in edu.uci.ics.jung.algorithms.transformation with type arguments of type Graph | ||
---|---|---|
static
|
FoldingTransformer.foldHypergraphEdges(Hypergraph<V,E> h,
org.apache.commons.collections15.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
|
FoldingTransformer.foldHypergraphEdges(Hypergraph<V,E> h,
org.apache.commons.collections15.Factory<Graph<V,E>> graph_factory,
org.apache.commons.collections15.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.collections15.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
|
FoldingTransformer.foldHypergraphVertices(Hypergraph<V,E> h,
org.apache.commons.collections15.Factory<Graph<E,F>> graph_factory,
org.apache.commons.collections15.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
|
FoldingTransformer.foldKPartiteGraph(KPartiteGraph<V,E> g,
org.apache.commons.collections15.Predicate<V> p,
org.apache.commons.collections15.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
|
FoldingTransformer.foldKPartiteGraph(KPartiteGraph<V,E> g,
org.apache.commons.collections15.Predicate<V> p,
org.apache.commons.collections15.Factory<Graph<V,E>> graph_factory,
org.apache.commons.collections15.Factory<E> edge_factory)
Converts g into a unipartite graph whose vertex set is the
vertices of g 's partition p . |
Constructor parameters in edu.uci.ics.jung.algorithms.transformation with type arguments of type Graph | |
---|---|
VertexPartitionCollapser(org.apache.commons.collections15.Factory<Graph<CV,CE>> graph_factory,
org.apache.commons.collections15.Factory<CV> vertex_factory,
org.apache.commons.collections15.Factory<CE> edge_factory)
Creates an instance with the specified graph and element factories. |
Uses of Graph in edu.uci.ics.jung.algorithms.util |
---|
Method parameters in edu.uci.ics.jung.algorithms.util with type arguments of type Graph | |
---|---|
boolean |
SelfLoopEdgePredicate.evaluate(Context<Graph<V,E>,E> context)
|
Uses of Graph in edu.uci.ics.jung.graph |
---|
Subinterfaces of Graph in edu.uci.ics.jung.graph | |
---|---|
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. |
Classes in edu.uci.ics.jung.graph that implement Graph | |
---|---|
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. |
Fields in edu.uci.ics.jung.graph declared as Graph | |
---|---|
protected Graph<V,E> |
GraphDecorator.delegate
|
Methods in edu.uci.ics.jung.graph that return types with arguments of type Graph | ||
---|---|---|
static
|
SparseMultigraph.getFactory()
Returns a Factory that creates an instance of this graph type. |
|
static
|
SparseGraph.getFactory()
Returns a Factory that creates an instance of this graph type. |
|
static
|
SortedSparseMultigraph.getFactory()
Returns a Factory that creates an instance of this graph type. |
|
static
|
OrderedSparseMultigraph.getFactory()
Returns a Factory that creates an instance of this graph type. |
Constructors in edu.uci.ics.jung.graph with parameters of type Graph | |
---|---|
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 . |
Uses of Graph in edu.uci.ics.jung.graph.event |
---|
Fields in edu.uci.ics.jung.graph.event declared as Graph | |
---|---|
protected Graph<V,E> |
GraphEvent.source
|
Methods in edu.uci.ics.jung.graph.event that return Graph | |
---|---|
Graph<V,E> |
GraphEvent.getSource()
|
Constructors in edu.uci.ics.jung.graph.event with parameters of type Graph | |
---|---|
GraphEvent.Edge(Graph<V,E> source,
GraphEvent.Type type,
E edge)
Creates a graph event for the specified graph, edge, and type. |
|
GraphEvent.Vertex(Graph<V,E> source,
GraphEvent.Type type,
V vertex)
Creates a graph event for the specified graph, vertex, and type. |
|
GraphEvent(Graph<V,E> source,
GraphEvent.Type type)
Creates an instance with the specified source graph and Type
(vertex/edge addition/removal). |
Uses of Graph in edu.uci.ics.jung.graph.util |
---|
Fields in edu.uci.ics.jung.graph.util with type parameters of type Graph | |
---|---|
protected Map<Context<Graph<V,E>,E>,Integer> |
DefaultParallelEdgeIndexFunction.edge_index
|
Methods in edu.uci.ics.jung.graph.util that return Graph | ||
---|---|---|
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
|
Graphs.synchronizedGraph(Graph<V,E> graph)
Returns a synchronized graph backed by the passed argument graph. |
|
static
|
Graphs.unmodifiableGraph(Graph<V,E> graph)
Returns an unmodifiable Graph backed by the passed Graph. |
Methods in edu.uci.ics.jung.graph.util with parameters of type Graph | ||
---|---|---|
int |
IncidentEdgeIndexFunction.getIndex(Graph<V,E> graph,
E e)
Returns the index for the specified edge. |
|
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 . |
|
protected int |
IncidentEdgeIndexFunction.getIndex(Graph<V,E> graph,
E e,
V v)
|
|
protected int |
DefaultParallelEdgeIndexFunction.getIndex(Graph<V,E> graph,
E e,
V v)
|
|
protected int |
IncidentEdgeIndexFunction.getIndex(Graph<V,E> graph,
E e,
V u,
V v)
|
|
protected int |
DefaultParallelEdgeIndexFunction.getIndex(Graph<V,E> graph,
E e,
V v,
V u)
|
|
void |
IncidentEdgeIndexFunction.reset(Graph<V,E> graph,
E e)
Resets the indices for this edge and its parallel edges. |
|
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. |
|
static
|
Graphs.synchronizedGraph(Graph<V,E> graph)
Returns a synchronized graph backed by the passed argument graph. |
|
static
|
Graphs.unmodifiableGraph(Graph<V,E> graph)
Returns an unmodifiable Graph backed by the passed Graph. |
Uses of Graph in edu.uci.ics.jung.io |
---|
Classes in edu.uci.ics.jung.io with type parameters of type Graph | |
---|---|
class |
PajekNetReader<G extends Graph<V,E>,V,E>
Reads a Graph from a Pajek NET formatted source. |
Methods in edu.uci.ics.jung.io that return Graph | |
---|---|
Graph<V,E> |
MatrixFile.load(BufferedReader reader)
Loads a graph from an input reader |
Graph<V,E> |
MatrixFile.load(String filename)
Loads a graph from a file. |
Graph<V,E> |
GraphFile.load(String filename)
Loads a graph from a file per the appropriate format |
Methods in edu.uci.ics.jung.io with parameters of type Graph | |
---|---|
protected E |
PajekNetReader.createAddEdge(StringTokenizer st,
V v1,
EdgeType directed,
Graph<V,E> g,
List<V> id,
org.apache.commons.collections15.Factory<E> edge_factory)
|
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 |
MatrixFile.save(Graph<V,E> graph,
String filename)
Saves a graph to a file |
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,
org.apache.commons.collections15.Transformer<V,String> vs,
org.apache.commons.collections15.Transformer<E,Number> nev)
Saves g to filename . |
void |
PajekNetWriter.save(Graph<V,E> g,
String filename,
org.apache.commons.collections15.Transformer<V,String> vs,
org.apache.commons.collections15.Transformer<E,Number> nev,
org.apache.commons.collections15.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.collections15.Transformer<V,String> vs,
org.apache.commons.collections15.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.collections15.Transformer<V,String> vs,
org.apache.commons.collections15.Transformer<E,Number> nev,
org.apache.commons.collections15.Transformer<V,Point2D> vld)
Writes graph to w . |
Constructor parameters in edu.uci.ics.jung.io with type arguments of type Graph | |
---|---|
MatrixFile(Map<E,Number> weightKey,
org.apache.commons.collections15.Factory<? extends Graph<V,E>> graphFactory,
org.apache.commons.collections15.Factory<V> vertexFactory,
org.apache.commons.collections15.Factory<E> edgeFactory)
Constructs MatrixFile instance. |
Uses of Graph in edu.uci.ics.jung.samples |
---|
Fields in edu.uci.ics.jung.samples declared as Graph | |
---|---|
protected static Graph<? extends Object,? extends Object>[] |
ShowLayouts.g_array
|
Fields in edu.uci.ics.jung.samples with type parameters of type Graph | |
---|---|
protected org.apache.commons.collections15.Predicate<Context<Graph<Integer,Number>,Number>> |
PluggableRendererDemo.self_loop
|
Methods in edu.uci.ics.jung.samples that return Graph | |
---|---|
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. |
Uses of Graph in edu.uci.ics.jung.visualization |
---|
Fields in edu.uci.ics.jung.visualization with type parameters of type Graph | |
---|---|
protected org.apache.commons.collections15.Predicate<Context<Graph<V,E>,E>> |
PluggableRenderContext.edgeArrowPredicate
|
protected org.apache.commons.collections15.Transformer<Context<Graph<V,E>,E>,Shape> |
PluggableRenderContext.edgeArrowTransformer
|
protected org.apache.commons.collections15.Predicate<Context<Graph<V,E>,E>> |
PluggableRenderContext.edgeIncludePredicate
|
protected org.apache.commons.collections15.Transformer<Context<Graph<V,E>,E>,Number> |
PluggableRenderContext.edgeLabelClosenessTransformer
|
protected org.apache.commons.collections15.Transformer<Context<Graph<V,E>,E>,Shape> |
PluggableRenderContext.edgeShapeTransformer
|
protected org.apache.commons.collections15.Predicate<Context<Graph<V,E>,V>> |
PluggableRenderContext.vertexIncludePredicate
|
Methods in edu.uci.ics.jung.visualization that return types with arguments of type Graph | |
---|---|
org.apache.commons.collections15.Predicate<Context<Graph<V,E>,E>> |
RenderContext.getEdgeArrowPredicate()
|
org.apache.commons.collections15.Predicate<Context<Graph<V,E>,E>> |
PluggableRenderContext.getEdgeArrowPredicate()
|
org.apache.commons.collections15.Transformer<Context<Graph<V,E>,E>,Shape> |
RenderContext.getEdgeArrowTransformer()
|
org.apache.commons.collections15.Transformer<Context<Graph<V,E>,E>,Shape> |
PluggableRenderContext.getEdgeArrowTransformer()
|
org.apache.commons.collections15.Predicate<Context<Graph<V,E>,E>> |
RenderContext.getEdgeIncludePredicate()
|
org.apache.commons.collections15.Predicate<Context<Graph<V,E>,E>> |
PluggableRenderContext.getEdgeIncludePredicate()
|
org.apache.commons.collections15.Transformer<Context<Graph<V,E>,E>,Number> |
RenderContext.getEdgeLabelClosenessTransformer()
|
org.apache.commons.collections15.Transformer<Context<Graph<V,E>,E>,Number> |
PluggableRenderContext.getEdgeLabelClosenessTransformer()
|
org.apache.commons.collections15.Transformer<Context<Graph<V,E>,E>,Shape> |
RenderContext.getEdgeShapeTransformer()
|
org.apache.commons.collections15.Transformer<Context<Graph<V,E>,E>,Shape> |
PluggableRenderContext.getEdgeShapeTransformer()
|
org.apache.commons.collections15.Predicate<Context<Graph<V,E>,V>> |
RenderContext.getVertexIncludePredicate()
|
org.apache.commons.collections15.Predicate<Context<Graph<V,E>,V>> |
PluggableRenderContext.getVertexIncludePredicate()
|
Method parameters in edu.uci.ics.jung.visualization with type arguments of type Graph | |
---|---|
boolean |
RenderContext.DirectedEdgeArrowPredicate.evaluate(Context<Graph<V,E>,E> c)
|
boolean |
RenderContext.UndirectedEdgeArrowPredicate.evaluate(Context<Graph<V,E>,E> c)
|
void |
RenderContext.setEdgeArrowPredicate(org.apache.commons.collections15.Predicate<Context<Graph<V,E>,E>> edgeArrowPredicate)
|
void |
PluggableRenderContext.setEdgeArrowPredicate(org.apache.commons.collections15.Predicate<Context<Graph<V,E>,E>> edgeArrowPredicate)
|
void |
RenderContext.setEdgeArrowTransformer(org.apache.commons.collections15.Transformer<Context<Graph<V,E>,E>,Shape> edgeArrowTransformer)
|
void |
PluggableRenderContext.setEdgeArrowTransformer(org.apache.commons.collections15.Transformer<Context<Graph<V,E>,E>,Shape> edgeArrowTransformer)
|
void |
RenderContext.setEdgeIncludePredicate(org.apache.commons.collections15.Predicate<Context<Graph<V,E>,E>> edgeIncludePredicate)
|
void |
PluggableRenderContext.setEdgeIncludePredicate(org.apache.commons.collections15.Predicate<Context<Graph<V,E>,E>> edgeIncludePredicate)
|
void |
RenderContext.setEdgeLabelClosenessTransformer(org.apache.commons.collections15.Transformer<Context<Graph<V,E>,E>,Number> edgeLabelClosenessTransformer)
|
void |
PluggableRenderContext.setEdgeLabelClosenessTransformer(org.apache.commons.collections15.Transformer<Context<Graph<V,E>,E>,Number> edgeLabelClosenessTransformer)
|
void |
RenderContext.setEdgeShapeTransformer(org.apache.commons.collections15.Transformer<Context<Graph<V,E>,E>,Shape> edgeShapeTransformer)
|
void |
PluggableRenderContext.setEdgeShapeTransformer(org.apache.commons.collections15.Transformer<Context<Graph<V,E>,E>,Shape> edgeShapeTransformer)
|
void |
RenderContext.setVertexIncludePredicate(org.apache.commons.collections15.Predicate<Context<Graph<V,E>,V>> vertexIncludePredicate)
|
void |
PluggableRenderContext.setVertexIncludePredicate(org.apache.commons.collections15.Predicate<Context<Graph<V,E>,V>> vertexIncludePredicate)
|
Uses of Graph in edu.uci.ics.jung.visualization.decorators |
---|
Fields in edu.uci.ics.jung.visualization.decorators with type parameters of type Graph | |
---|---|
protected org.apache.commons.collections15.Predicate<Context<Graph<V,E>,E>> |
GradientEdgePaintTransformer.selfLoop
|
Method parameters in edu.uci.ics.jung.visualization.decorators with type arguments of type Graph | |
---|---|
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)
|
Uses of Graph in edu.uci.ics.jung.visualization.layout |
---|
Fields in edu.uci.ics.jung.visualization.layout declared as Graph | |
---|---|
protected Graph<V,E> |
BoundingRectanglePaintable.graph
|
protected Graph<V,E> |
BoundingRectangleCollector.graph
|
Methods in edu.uci.ics.jung.visualization.layout with parameters of type Graph | |
---|---|
void |
ObservableCachingLayout.setGraph(Graph<V,E> graph)
|
void |
CachingLayout.setGraph(Graph<V,E> graph)
|
Uses of Graph in edu.uci.ics.jung.visualization.picking |
---|
Method parameters in edu.uci.ics.jung.visualization.picking with type arguments of type Graph | |
---|---|
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. |
Uses of Graph in edu.uci.ics.jung.visualization.subLayout |
---|
Methods in edu.uci.ics.jung.visualization.subLayout that return Graph | |
---|---|
Graph |
GraphCollapser.collapse(Graph inGraph,
Graph clusterGraph)
|
Graph |
GraphCollapser.expand(Graph inGraph,
Graph clusterGraph)
|
Graph |
GraphCollapser.getClusterGraph(Graph inGraph,
Collection picked)
|
Methods in edu.uci.ics.jung.visualization.subLayout with parameters of type Graph | |
---|---|
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)
|
Constructors in edu.uci.ics.jung.visualization.subLayout with parameters of type Graph | |
---|---|
GraphCollapser(Graph originalGraph)
|
Uses of Graph in edu.uci.ics.jung.visualization.util |
---|
Methods in edu.uci.ics.jung.visualization.util with parameters of type Graph | |
---|---|
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. |
Uses of Graph in edu.uci.ics.jung.visualization3d |
---|
Fields in edu.uci.ics.jung.visualization3d with type parameters of type Graph | |
---|---|
protected org.apache.commons.collections15.Transformer<Context<Graph<V,E>,E>,javax.media.j3d.Node> |
PluggableRenderContext.edgeShapeTransformer
|
Methods in edu.uci.ics.jung.visualization3d that return types with arguments of type Graph | |
---|---|
org.apache.commons.collections15.Transformer<Context<Graph<V,E>,E>,javax.media.j3d.Node> |
RenderContext.getEdgeShapeTransformer()
|
org.apache.commons.collections15.Transformer<Context<Graph<V,E>,E>,javax.media.j3d.Node> |
PluggableRenderContext.getEdgeShapeTransformer()
|
Method parameters in edu.uci.ics.jung.visualization3d with type arguments of type Graph | |
---|---|
void |
RenderContext.setEdgeShapeTransformer(org.apache.commons.collections15.Transformer<Context<Graph<V,E>,E>,javax.media.j3d.Node> edgeShapeTransformer)
|
void |
PluggableRenderContext.setEdgeShapeTransformer(org.apache.commons.collections15.Transformer<Context<Graph<V,E>,E>,javax.media.j3d.Node> edgeShapeTransformer)
|
Uses of Graph in edu.uci.ics.jung.visualization3d.layout |
---|
Methods in edu.uci.ics.jung.visualization3d.layout that return Graph | |
---|---|
Graph<V,E> |
LayoutDecorator.getGraph()
|
Methods in edu.uci.ics.jung.visualization3d.layout with parameters of type Graph | |
---|---|
void |
LayoutEventBroadcaster.setGraph(Graph<V,E> graph)
|
void |
LayoutDecorator.setGraph(Graph<V,E> graph)
|
|
||||||||||
PREV NEXT | FRAMES NO FRAMES |