Package | Description |
---|---|
edu.uci.ics.jung.algorithms |
Provides a set of specialized algorithms for computing various measures on graphs as well as transforming graphs in different ways.
|
edu.uci.ics.jung.algorithms.blockmodel |
Implementations of a notion of graph equivalence for blockmodeling, and a mechanism for collapsing blocks.
|
edu.uci.ics.jung.algorithms.cluster |
Provides a series of methods for locating clusters in graphs according to some model-based, heuristic or graph-theoretic criteria.
|
edu.uci.ics.jung.algorithms.connectivity |
Provides a series of methods for computing various aspects of a graph's overall connectivity structure.
|
edu.uci.ics.jung.algorithms.importance |
Provides a set of algorithms for computing the importance of each node (or edge)
in a graph relative to all others (or, for the algorithms that inherit from
RelativeAuthorityRanker , relative to a specified subset of elements). |
edu.uci.ics.jung.algorithms.shortestpath |
Provides a set of algorithms for computing the shortest path between two nodes or between each pair of nodes in a graph.
|
edu.uci.ics.jung.algorithms.transformation | |
edu.uci.ics.jung.graph |
Specifies the interfaces for and capabilities of the JUNG vertex, edge, and graph classes.
|
edu.uci.ics.jung.graph.decorators |
Provides mechanisms for annotating nodes consistently with useful information.
|
edu.uci.ics.jung.graph.filters |
Provides for a filtering mechanism that produces subgraphs of an original graph.
|
edu.uci.ics.jung.graph.filters.impl |
Provides sample implementations and generally useful filters.
|
edu.uci.ics.jung.graph.impl |
Implementations of the JUNG vertex, edge, and graph interfaces.
|
edu.uci.ics.jung.io |
Provides a set of graph file format interpreters for loading graphs from disk.
|
edu.uci.ics.jung.random.generators |
Provides a series of methods for generating new graphs with various properties.
|
edu.uci.ics.jung.random.permuters |
Provides a series of methods for permuting graphs in different ways.
|
edu.uci.ics.jung.utils |
Provides a series of useful utility methods, and a number of custom helper classes designed specifically for this application.
|
edu.uci.ics.jung.visualization |
Provides a visualization mechanism for drawing and rendering Graphs.
|
edu.uci.ics.jung.visualization.contrib |
These are additional layouts contributed by various users.
|
samples.graph |
Provides sample graph code that may be of interest.
|
samples.preview_new_graphdraw |
This module provides a new way of thinking about graph drawing.
|
samples.preview_new_graphdraw.impl | |
samples.preview_new_graphdraw.iter | |
samples.preview_new_graphdraw.staticlayouts | |
scratch.danyel | |
scratch.danyel.lazy | |
scratch.danyel.sample | |
scratch.joshua.ranking | |
scratch.scott | |
scratch.scott.registry | |
scratch.scott.sample | |
test.edu.uci.ics.jung.algorithms.cluster | |
test.edu.uci.ics.jung.algorithms.importance | |
test.edu.uci.ics.jung.algorithms.shortestpath | |
test.edu.uci.ics.jung.graph.impl | |
test.edu.uci.ics.jung.graph.predicates | |
test.edu.uci.ics.jung.visualization |
Modifier and Type | Method and Description |
---|---|
static Graph |
GraphMatrixOperations.matrixToGraph(cern.colt.matrix.DoubleMatrix2D matrix)
Creates a graph from a square (weighted) adjacency matrix.
|
static Graph |
GraphMatrixOperations.matrixToGraph(cern.colt.matrix.DoubleMatrix2D matrix,
NumberEdgeValue nev)
Creates a graph from a square (weighted) adjacency matrix.
|
static Graph |
GraphMatrixOperations.matrixToGraph(cern.colt.matrix.DoubleMatrix2D matrix,
java.lang.String weightKey)
Creates a graph from a square (weighted) adjacency matrix.
|
static Graph |
GraphMatrixOperations.square(Graph g,
MatrixElementOperations meo)
Returns the graph that corresponds to the square of the (weighted)
adjacency matrix that the specified graph
g encodes. |
Modifier and Type | Method and Description |
---|---|
static cern.colt.matrix.DoubleMatrix2D |
GraphMatrixOperations.computeMeanFirstPassageMatrix(Graph G,
java.lang.Object edgeWeightKey,
cern.colt.matrix.DoubleMatrix1D stationaryDistribution)
Computes the all-pairs mean first passage time for the specified graph,
given an existing stationary probability distribution.
|
static cern.colt.matrix.impl.SparseDoubleMatrix2D |
GraphMatrixOperations.createVertexDegreeDiagonalMatrix(Graph G)
Returns a diagonal matrix whose diagonal entries contain the degree for
the corresponding node.
|
static cern.colt.matrix.impl.SparseDoubleMatrix2D |
GraphMatrixOperations.graphToSparseMatrix(Graph g) |
static cern.colt.matrix.impl.SparseDoubleMatrix2D |
GraphMatrixOperations.graphToSparseMatrix(Graph g,
NumberEdgeValue nev)
Returns a SparseDoubleMatrix2D whose entries represent the edge weights for the
edges in
g , as specified by nev . |
static cern.colt.matrix.impl.SparseDoubleMatrix2D |
GraphMatrixOperations.graphToSparseMatrix(Graph g,
java.lang.Object edgeWeightKey)
Returns a SparseDoubleMatrix2D which represents the edge weights of the
input Graph.
|
static Graph |
GraphMatrixOperations.square(Graph g,
MatrixElementOperations meo)
Returns the graph that corresponds to the square of the (weighted)
adjacency matrix that the specified graph
g encodes. |
Modifier and Type | Method and Description |
---|---|
Graph |
GraphCollapser.getCollapsedGraph(EquivalenceRelation equivalence)
This version collects sets of vertices in an equivalence relation into a single CollapsedVertex.
|
Graph |
GraphCollapser.getCollapsedGraph(Graph g,
java.util.Set rootSet)
This function collapses a series of vertices in one
EquivalenceSet into one
CollapsedVertex.
|
Graph |
EquivalenceRelation.getGraph()
Returns the common graph to which all the vertices belong
|
Modifier and Type | Method and Description |
---|---|
java.util.Set |
StructurallyEquivalent.checkEquivalent(Graph 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.
|
java.util.Set |
StructurallyEquivalentII.checkEquivalent(Graph 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 GraphCollapser.CollapsedVertex |
BipartiteGraphCollapser.createCollapsedVertex(Graph g,
java.util.Set rootSet)
It must be the case that all members of rootSet are in the same partition.
|
protected GraphCollapser.CollapsedVertex |
GraphCollapser.createCollapsedVertex(Graph g,
java.util.Set rootSet)
Overridable method to create a single vertex representing a set of vertices in the
graph.
|
protected void |
GraphCollapser.createDirectedEdges(Graph graph,
GraphCollapser.CollapsedVertex superVertex,
Vertex opposite,
java.util.Set relevantEdges)
Overridable method to create a up to two directed edges that represents the data in its parameters.
|
protected void |
GraphCollapser.createEdgesCorrespondingToMap(Graph copy,
GraphCollapser.CollapsedVertex cv,
org.apache.commons.collections.MultiMap vertices_to_edges,
java.util.Set coveredCV)
INTERNAL METHOD
|
protected EquivalenceRelation |
StructurallyEquivalent.createEquivalenceClasses(Graph g,
java.util.Set s)
Takes in a Set of Pairs (as in the resutls of checkEquivalent) and
massages into a Set of Sets, where each Set is an equivalence class.
|
protected void |
BipartiteGraphCollapser.createUndirectedEdge(Graph g,
GraphCollapser.CollapsedVertex superVertex,
Vertex opposite,
java.util.Set relevantEdges) |
protected void |
GraphCollapser.createUndirectedEdge(Graph g,
GraphCollapser.CollapsedVertex superVertex,
Vertex opposite,
java.util.Set relevantEdges)
Overridable method to create a single undirected edge that represents the data in its parameters.
|
Graph |
GraphCollapser.getCollapsedGraph(Graph g,
java.util.Set rootSet)
This function collapses a series of vertices in one
EquivalenceSet into one
CollapsedVertex.
|
EquivalenceRelation |
EquivalenceAlgorithm.getEquivalences(Graph g)
Runs the equivalence algorithm on the given graph,
and returns an equivalence relation.
|
EquivalenceRelation |
StructurallyEquivalent.getEquivalences(Graph g) |
protected void |
GraphCollapser.replaceEquivalencesWithCollapsedVertices(EquivalenceRelation er,
Graph copy,
java.util.Map superVertices)
INTERNAL (undocumented) method.
|
Constructor and Description |
---|
EquivalenceRelation(java.util.Set rv,
Graph g)
Input is the basic data structure underneath: a Set of Sets.
|
Modifier and Type | Method and Description |
---|---|
abstract Graph |
ClusterSet.getClusterAsNewSubGraph(int index)
Constructs a new graph from the given cluster
|
Graph |
EdgeClusterSet.getClusterAsNewSubGraph(int index)
Constructs a new graph from the given cluster
|
Graph |
VertexClusterSet.getClusterAsNewSubGraph(int index)
Constructs a new graph from the given cluster
|
Modifier and Type | Method and Description |
---|---|
abstract ClusterSet |
ClusterSet.createEquivalentClusterSet(Graph anotherGraph)
Returns the corresponding cluster set in the other graph.
|
ClusterSet |
EdgeClusterSet.createEquivalentClusterSet(Graph anotherGraph)
Creates a new cluster set where each edge and cluster in the new cluster set correspond 1-to-1 with those in
the original graph
|
ClusterSet |
VertexClusterSet.createEquivalentClusterSet(Graph anotherGraph)
Creates a new cluster set where each vertex and cluster in the new cluster set correspond 1-to-1 with
those in the original graph
|
Constructor and Description |
---|
EdgeClusterSet(Graph underlyingGraph)
Constructs and initializes the set
|
Modifier and Type | Method and Description |
---|---|
static Graph |
KNeighborhoodExtractor.extractInDirectedNeighborhood(DirectedGraph graph,
java.util.Set rootNodes,
int radiusK)
Extracts the subgraph comprised of all vertices within distance K (in-directed) from any
node in rootNodes.
|
static Graph |
KNeighborhoodExtractor.extractNeighborhood(Graph graph,
java.util.Set rootNodes,
int radiusK)
Extracts the subgraph comprised of all vertices within distance K (undirected) from any
node in rootNodes.
|
static Graph |
KNeighborhoodExtractor.extractOutDirectedNeighborhood(DirectedGraph graph,
java.util.Set rootNodes,
int radiusK)
Extracts the subgraph comprised of all vertices within distance K (out-directed) from any
node in rootNodes.
|
Modifier and Type | Method and Description |
---|---|
static Graph |
KNeighborhoodExtractor.extractNeighborhood(Graph graph,
java.util.Set rootNodes,
int radiusK)
Extracts the subgraph comprised of all vertices within distance K (undirected) from any
node in rootNodes.
|
int |
BFSDistanceLabeler.getDistance(Graph g,
Vertex v)
Given a vertex, returns the shortest distance from any node in the root set to v
|
protected void |
BFSDistanceLabeler.initialize(Graph g,
java.util.Set rootSet) |
void |
BFSDistanceLabeler.labelDistances(Graph graph,
java.util.Set rootSet)
Computes the distances of all the node from the starting root nodes.
|
void |
BFSDistanceLabeler.labelDistances(Graph graph,
Vertex root)
Computes the distances of all the node from the specified root node.
|
void |
BFSDistanceLabeler.removeDecorations(Graph g) |
Modifier and Type | Method and Description |
---|---|
protected Graph |
AbstractRanker.getGraph() |
Modifier and Type | Method and Description |
---|---|
void |
VoltageRanker.calculateVoltages(Graph g,
java.util.Map source_voltages,
java.util.Set sinks)
Calculates the voltages for
g based on the specified source
and sink vertex sets. |
void |
VoltageRanker.calculateVoltages(Graph g,
java.util.Set sources,
java.util.Set sinks)
Calculates the voltages for
g based on assigning each of the
vertices in source a voltage of 1 V. |
protected void |
BetweennessCentrality.computeBetweenness(Graph graph) |
protected void |
HITS.initialize(Graph g) |
protected void |
AbstractRanker.initialize(Graph graph,
boolean isNodeRanker,
boolean isEdgeRanker) |
protected void |
HITSWithPriors.initialize(Graph g,
java.lang.String edgeWeightKeyName) |
Constructor and Description |
---|
BaryCenter(Graph g)
Constructor which initializes the algorithm
|
BetweennessCentrality(Graph g)
Constructor which initializes the algorithm
|
BetweennessCentrality(Graph g,
boolean rankNodes) |
BetweennessCentrality(Graph g,
boolean rankNodes,
boolean rankEdges) |
DegreeDistributionRanker(Graph graph)
Default constructor which assumes if the graph is directed the indegree is to be used.
|
DegreeDistributionRanker(Graph graph,
boolean useInDegree)
This constructor allows you to specify whether to use indegree or outdegree.
|
HITS(Graph graph)
Constructs an instance of the ranker where the type of importance that is associated with the
rank score is the node's importance as an authority.
|
HITS(Graph graph,
boolean useAuthorityForRanking)
Constructs an instance of the ranker where the type of importance that is associated with the
rank score is the node's importance as an authority.
|
HITSWithPriors(Graph graph,
boolean useAuthorityForRanking,
double bias,
java.util.Set priors,
java.lang.String edgeWeightKey)
More specialized constructor where the type of importance can be specified.
|
HITSWithPriors(Graph graph,
double bias,
java.util.Set priors)
Constructs an instance of the ranker where the type of importance that is associated with the
rank score is the node's importance as an authority.
|
Constructor and Description |
---|
UnweightedShortestPath(Graph g)
Constructs and initializes algorithm
|
Modifier and Type | Method and Description |
---|---|
protected Graph |
FoldingTransformer.createGraph()
Returns a base graph to use.
|
Graph |
FoldingTransformer.fold(Hypergraph h,
Graph target,
boolean use_vertices,
NumberEdgeValue nev,
org.apache.commons.collections.BidiMap map)
Creates a
Graph which is a "folded" version of h . |
Graph |
FoldingTransformer.fold(KPartiteGraph g,
org.apache.commons.collections.Predicate p)
Equivalent to
fold(g, p, null) . |
Graph |
FoldingTransformer.fold(KPartiteGraph g,
org.apache.commons.collections.Predicate p,
NumberEdgeValue nev)
Converts
g into a unipartite graph whose vertex set is the
vertices whose partition is specified by p . |
Modifier and Type | Method and Description |
---|---|
protected void |
FoldingTransformer.addEdge(Graph newGraph,
Vertex firstEnd,
Element intermediate,
Vertex secondEnd,
NumberEdgeValue nev)
Creates a new edge from
firstEnd to secondEnd
in newGraph . |
protected static java.util.Map |
DirectionTransformer.convertVertices(Graph old,
Graph transformed,
boolean copy)
Puts a version of each vertex from
old into
transformed . |
Graph |
FoldingTransformer.fold(Hypergraph h,
Graph target,
boolean use_vertices,
NumberEdgeValue nev,
org.apache.commons.collections.BidiMap map)
Creates a
Graph which is a "folded" version of h . |
static DirectedGraph |
DirectionTransformer.toDirected(Graph graph)
Transforms
graph (which may be of any directionality)
into a directed graph without
parallel edges. |
static DirectedGraph |
DirectionTransformer.toDirected(Graph graph,
boolean copy)
Transforms
graph (which may be of any directionality)
into a directed graph. |
static UndirectedGraph |
DirectionTransformer.toUndirected(Graph graph)
Transforms
graph (which may be of any directionality)
into an undirected graph without
parallel edges. |
static UndirectedGraph |
DirectionTransformer.toUndirected(Graph graph,
boolean copy)
Transforms
graph (which may be of any directionality)
into an undirected graph. |
Modifier and Type | Interface and Description |
---|---|
interface |
DirectedGraph
A tagging interface for implementations of
Graph
whose edge set consists of implementations of DirectedEdge . |
interface |
KPartiteGraph
An interface for k-partite graphs.
|
interface |
UndirectedGraph
A tagging interface for implementations of
Graph
whose edge set consists of implementations of UndirectedEdge . |
Modifier and Type | Field and Description |
---|---|
protected Graph |
StringLabeller.graph |
Modifier and Type | Method and Description |
---|---|
Graph |
EdgeWeightLabeller.getGraph()
Returns the graph associated with this particular
labeller.
|
Graph |
StringLabeller.getGraph()
Gets the graph associated with this StringLabeller
|
Modifier and Type | Method and Description |
---|---|
static EdgeWeightLabeller |
EdgeWeightLabeller.getLabeller(Graph g)
Finds or creates an edge labeller for the graph, using
the default user data key.
|
static StringLabeller |
GlobalStringLabeller.getLabeller(Graph g) |
static StringLabeller |
StringLabeller.getLabeller(Graph g)
Gets a labeller associated with this graph.
|
static EdgeWeightLabeller |
EdgeWeightLabeller.getLabeller(Graph g,
java.lang.Object key)
Finds or creates an edge labeleller for the graph, using
the given userdata key.
|
static StringLabeller |
StringLabeller.getLabeller(Graph g,
java.lang.Object key)
Returns a labeller attached to a particular key in the graph.
|
static boolean |
GlobalStringLabeller.hasStringLabeller(Graph g)
Checks if a labeller--any labeller--is associated with this graph.
|
static boolean |
StringLabeller.hasStringLabeller(Graph g)
Checks if a labeller is associated with this graph.
|
static boolean |
GlobalStringLabeller.hasStringLabeller(Graph g,
java.lang.Object key)
Checks for a labeller attached to a particular key in the graph.
|
static boolean |
StringLabeller.hasStringLabeller(Graph g,
java.lang.Object key)
Checks for a labeller attached to a particular key in the graph.
|
static boolean |
EdgeWeightLabeller.hasWeightLabeller(Graph g)
Checks for an edge labeleller for the graph, using
the default user data key.
|
static boolean |
EdgeWeightLabeller.hasWeightLabeller(Graph g,
java.lang.Object key)
Checks an edge labeleller for the graph at the given key.
|
static StringLabeller |
GlobalStringLabeller.setLabellerTo(Graph g)
Sets the default StringLabeller of this graph to be a ToStringLabeller.
|
static StringLabeller |
ToStringLabeller.setLabellerTo(Graph g)
Sets the default StringLabeller of this graph to be a ToStringLabeller.
|
static StringLabeller |
GlobalStringLabeller.setLabellerTo(Graph g,
java.lang.Object key)
Sets the StringLabeller of this graph, at this key, to be a
ToStringLabeller.
|
static StringLabeller |
ToStringLabeller.setLabellerTo(Graph g,
java.lang.Object key)
Sets the StringLabeller of this graph, at this key, to be a
ToStringLabeller.
|
Constructor and Description |
---|
StringLabeller(Graph g) |
ToStringLabeller(Graph g) |
Modifier and Type | Field and Description |
---|---|
protected Graph |
UnassembledGraph.originalGraph |
Modifier and Type | Method and Description |
---|---|
Graph |
UnassembledGraph.assemble() |
Graph |
UnassembledGraph.assemble(boolean shouldPreserveRecord)
Constructs a new graph based on the source graph.
|
Graph |
GraphAssemblyRecord.getOriginalExtended()
Returns the first original graph
If the original graph was generated by a different filter (as in the
first example at
EfficientFilter ,
then there is a "previous" graph--and thus a previous GraphAssemblyRecord. |
Graph |
GraphAssemblyRecord.getOriginalGraph()
Returns the original graph that created this subset.
|
Graph |
UnassembledGraph.getOriginalGraph()
Returns the original graph that was subsetted for this UnsassembledGraph.
|
Modifier and Type | Method and Description |
---|---|
UnassembledGraph |
Filter.filter(Graph g)
Filters a graph by returning an UnassembledGraph consisting
of nodes and edges that pass the filter.
|
UnassembledGraph |
GeneralEdgeAcceptFilter.filter(Graph g)
Returns an UnassembledGraph with the subset
of edges that pass acceptEdge.
|
UnassembledGraph |
GeneralVertexAcceptFilter.filter(Graph g)
This method does the actual filtering of the the graph.
|
UnassembledGraph |
SerialFilter.filter(Graph g)
Runs through the sequence of filters, one at a time.
|
static GraphAssemblyRecord |
GraphAssemblyRecord.getAssemblyRecord(Graph g)
Returns the GraphAssemblyRecord for a particular graph.
|
Constructor and Description |
---|
UnassembledGraph(Filter f,
java.util.Set vertices,
java.util.Set edges,
Graph original) |
UnassembledGraph(java.lang.String name,
java.util.Set vertices,
java.util.Set edges,
Graph original)
A constructor that uses non-Filters (for example, GraphCluterers) to
build themselves.
|
Modifier and Type | Method and Description |
---|---|
UnassembledGraph |
KNeighborhoodFilter.filter(Graph graph)
Constructs an unassembled graph containing the k-neighbhood around the root node(s)
|
Modifier and Type | Class and Description |
---|---|
class |
AbstractSparseGraph
This class provides a skeletal implementation of the
Graph
interface to minimize the effort required to implement this interface. |
class |
BipartiteGraph
A Bipartite graph is divided into A vertices and B vertices.
|
class |
DirectedSparseGraph
An implementation of
Graph that consists of a
Vertex set and a DirectedEdge set. |
class |
KPartiteSparseGraph
An implementation of KPartiteGraph based on SparseGraph.
|
class |
SparseGraph
An implementation of
AbstractSparseGraph that, by default, imposes no
constraints on the edges and vertices that may be added to it. |
class |
SparseTree
An implementation of
Graph that consists of a
Vertex set and a DirectedEdge set. |
class |
UndirectedSparseGraph
An implementation of
Graph that consists of a
Vertex set and an UndirectedEdge set. |
Modifier and Type | Method and Description |
---|---|
static Graph |
BipartiteGraph.fold(BipartiteGraph bpg,
BipartiteGraph.Choice vertexSet)
Creates a one-part graph from a bipartite graph by folding
Vertices from one class into a second class.
|
Constructor and Description |
---|
KPartiteSparseGraph(Graph g,
java.util.Collection partitions,
boolean subsets)
Creates a new
KPartiteSparseGraph which contains all the
vertices and edges in g . |
Modifier and Type | Method and Description |
---|---|
protected Graph |
GraphMLFileHandler.getGraph() |
Graph |
MatrixFile.load(java.io.BufferedReader reader)
Loads a graph from an input reader
|
Graph |
GraphMLFile.load(java.io.InputStream stream)
Deprecated.
generally, InputStreams are less robust than Readers
|
Graph |
GraphMLFile.load(java.io.Reader reader) |
Graph |
PajekNetFile.load(java.io.Reader read)
Deprecated.
Loads a graph for the given BufferedReader (where the data is assumed to be in Pajek NET format).
|
Graph |
PajekNetReader.load(java.io.Reader reader)
Returns
load(reader, new SparseGraph(), null) . |
Graph |
PajekNetReader.load(java.io.Reader reader,
Graph g)
Returns
load(reader, g, null) . |
Graph |
PajekNetReader.load(java.io.Reader reader,
Graph g,
NumberEdgeValue nev)
Returns
load(reader, g, nev, new TypedVertexGenerator(g)) . |
Graph |
PajekNetReader.load(java.io.Reader reader,
Graph g,
NumberEdgeValue nev,
VertexGenerator vg)
Populates the graph
g with the graph represented by the
Pajek-format data supplied by reader . |
Graph |
PajekNetReader.load(java.io.Reader reader,
NumberEdgeValue nev)
Returns
load(reader, new SparseGraph(), nev) . |
Graph |
GraphFile.load(java.lang.String filename)
Loads a graph from a file per the appropriate format
|
Graph |
GraphMLFile.load(java.lang.String filename)
Loads a graph from a GraphML file.
|
Graph |
MatrixFile.load(java.lang.String filename) |
Graph |
PajekNetFile.load(java.lang.String filename)
Deprecated.
Loads a graph from disk for the given .net file
If the edges are directed then a directed graph will be created, otherwise an undirected graph will be created
|
Graph |
PajekNetReader.load(java.lang.String filename)
Returns
load(filename, new SparseGraph(), null) . |
Graph |
PajekNetReader.load(java.lang.String filename,
Graph g)
Returns
load(filename, g, null) . |
Graph |
PajekNetReader.load(java.lang.String filename,
Graph g,
NumberEdgeValue nev)
Creates a
FileReader from filename , calls
load(reader, g, nev) , closes the reader, and returns
the resultant graph. |
Graph |
PajekNetReader.load(java.lang.String filename,
NumberEdgeValue nev)
Returns
load(filename, new SparseGraph(), nev) . |
Modifier and Type | Method and Description |
---|---|
protected Edge |
PajekNetReader.createAddEdge(java.util.StringTokenizer st,
Vertex v1,
boolean directed,
Graph g,
Indexer id,
boolean parallel_ok) |
Graph |
PajekNetReader.load(java.io.Reader reader,
Graph g)
Returns
load(reader, g, null) . |
Graph |
PajekNetReader.load(java.io.Reader reader,
Graph g,
NumberEdgeValue nev)
Returns
load(reader, g, nev, new TypedVertexGenerator(g)) . |
Graph |
PajekNetReader.load(java.io.Reader reader,
Graph g,
NumberEdgeValue nev,
VertexGenerator vg)
Populates the graph
g with the graph represented by the
Pajek-format data supplied by reader . |
Graph |
PajekNetReader.load(java.lang.String filename,
Graph g)
Returns
load(filename, g, null) . |
Graph |
PajekNetReader.load(java.lang.String filename,
Graph g,
NumberEdgeValue nev)
Creates a
FileReader from filename , calls
load(reader, g, nev) , closes the reader, and returns
the resultant graph. |
static int |
PartitionDecorationReader.loadCounts(Graph bg,
java.io.Reader count_reader,
org.apache.commons.collections.Predicate partition,
java.lang.Object count_key,
UserDataContainer.CopyAction copyact)
Decorates vertices in the specified partition with typed count data.
|
static void |
PartitionDecorationReader.loadCounts(Graph bg,
java.io.Reader count_reader,
org.apache.commons.collections.Predicate partition,
java.lang.Object count_key,
UserDataContainer.CopyAction copyact,
int num_types) |
static void |
PartitionDecorationReader.loadStrings(Graph bg,
java.io.Reader name_reader,
org.apache.commons.collections.Predicate partition,
java.lang.Object string_key)
Decorates vertices in the specified partition with strings.
|
void |
GraphMLFile.save(Graph g,
java.io.PrintStream out) |
void |
GraphFile.save(Graph graph,
java.lang.String filename)
Save a graph to disk per the appropriate format
|
void |
GraphMLFile.save(Graph g,
java.lang.String filename) |
void |
MatrixFile.save(Graph graph,
java.lang.String filename) |
void |
PajekNetFile.save(Graph graph,
java.lang.String filename)
Deprecated.
Writes
graph to the file specified by filename
in the Pajek NET format. |
void |
PajekNetWriter.save(Graph g,
java.lang.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 g,
java.lang.String filename,
VertexStringer vs,
NumberEdgeValue nev) |
void |
PajekNetWriter.save(Graph g,
java.lang.String filename,
VertexStringer vs,
NumberEdgeValue nev,
VertexLocationFunction vld)
Saves
g to filename . |
void |
PajekNetWriter.save(Graph g,
java.io.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 g,
java.io.Writer w,
VertexStringer vs,
NumberEdgeValue nev) |
void |
PajekNetWriter.save(Graph graph,
java.io.Writer w,
VertexStringer vs,
NumberEdgeValue nev,
VertexLocationFunction vld)
Writes
graph to w . |
Modifier and Type | Method and Description |
---|---|
protected Graph |
EppsteinPowerLawGenerator.initializeGraph() |
Modifier and Type | Method and Description |
---|---|
protected void |
BernoulliEdgePermuter.initialize(Graph g) |
void |
BernoulliEdgePermuter.permuteEdges(Graph graph)
Permutes the edges with default probability 1, meaning that if an edge is sample it will either be removed
or added depending on whether it exists already
|
void |
EdgePermuter.permuteEdges(Graph graph)
Instructs the algoritm to go ahead and permute the edges for the given graph
|
void |
BernoulliEdgePermuter.permuteEdges(Graph graph,
double probEdgeFlip)
Permutes the edges using a user-specified probability that an edge is removed or added.
|
Modifier and Type | Method and Description |
---|---|
static Graph |
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 |
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 |
GraphUtils.edgeSetToGraph(java.util.Set edges,
boolean retain)
Given a set of edges, creates a new Graph that contains all
of those edges, and at least all the vertices that are attached to them.
|
static Graph |
TestGraphs.generateMixedRandomGraph(NumberEdgeValue edge_weight,
int num_vertices)
Equivalent to
generateMixedRandomGraph(edge_weight, num_vertices, true) . |
static Graph |
TestGraphs.generateMixedRandomGraph(NumberEdgeValue edge_weights,
int num_vertices,
boolean parallel)
Returns a random mixed-mode graph.
|
static Graph |
TestGraphs.getDemoGraph()
Returns a bigger test graph with a clique, several components, and other
parts.
|
static Graph |
TestGraphs.getOneComponentGraph()
Returns a bigger, undirected test graph with a just one component.
|
static Graph |
GraphUtils.vertexSetToGraph(java.util.Set s)
Given a set of vertices, creates a new Graph that contains
all of those vertices, and all the edges that connect them.
|
Modifier and Type | Method and Description |
---|---|
static void |
GraphUtils.addDirectedVertices(Graph g,
int count)
Deprecated.
As of version 1.2, replaced by
GraphUtils.addVertices(edu.uci.ics.jung.graph.Graph, int) . |
static Edge |
GraphUtils.addEdge(Graph g,
Vertex v1,
Vertex v2)
Adds an appropriate edge between two vertices.
|
static void |
GraphUtils.addEdges(Graph g,
java.util.Set edges)
Adds all edges in the specified set to
g . |
static void |
GraphUtils.addUndirectedVertices(Graph g,
int count)
Deprecated.
As of version 1.2, replaced by
GraphUtils.addVertices(edu.uci.ics.jung.graph.Graph, int) . |
static void |
GraphUtils.addVertices(Graph g,
int count)
Adds
count vertices into a graph. |
static void |
GraphUtils.addVertices(Graph g,
java.util.Set vertices)
Adds all vertices in the specified set to
g . |
static boolean |
GraphProperties.containsParallelEdges(Graph g)
Checks to see whether the graphs contains parallel edges
|
static boolean |
GraphProperties.containsSelfLoops(Graph g)
Checks to see whether the graphs contains self-loops
|
static boolean |
PredicateUtils.enforcesDirected(Graph g)
Returns
true if g is constrained to only
accept directed edges, and false otherwise. |
static boolean |
PredicateUtils.enforcesNotParallel(Graph g)
Returns
true if g is constrained to
reject parallel edges. |
static boolean |
PredicateUtils.enforcesUndirected(Graph g)
Returns
true if g is constrained to only
accept undirected edges. |
protected java.lang.Integer |
ParallelEdgeIndexSingleton.getIndex_internal(Edge e,
Graph g) |
static boolean |
GraphProperties.isConnected(Graph g)
Checks to see whether the graph is connected.
|
static boolean |
GraphProperties.isSimple(Graph g)
Checks to see whether the graphs is simple (that is, whether it contains
parallel edges and self-loops).
|
static void |
GraphUtils.removeEdges(Graph g,
java.util.Set edges)
Removes all vertices in the specified set from
g . |
static void |
GraphUtils.removeVertices(Graph g,
java.util.Set vertices)
Removes all vertices in the specified set from
g . |
static DirectedGraph |
GraphUtils.transform(Graph uGraph)
Deprecated.
As of version 1.4, replaced by
DirectionTransformer.toDirected(Graph) |
static java.util.Set |
GraphUtils.translateAll(java.util.Set s,
Graph g)
Deprecated.
As of version 1.4, replaced by
GraphUtils.getEqualVertices(Set, ArchetypeGraph) |
static java.util.Set |
GraphUtils.translateAllEdges(java.util.Set s,
Graph g)
Deprecated.
As of version 1.4, replaced by
GraphUtils.getEqualEdges(Set, ArchetypeGraph) |
Modifier and Type | Method and Description |
---|---|
Graph |
AbstractLayout.getGraph()
Accessor for the graph that represets all vertices.
|
Graph |
FadingVertexLayout.getGraph()
Deprecated.
A pass-through.
|
Graph |
Layout.getGraph()
Returns the full graph (the one that was passed in at
construction time) that this Layout refers to.
|
Graph |
LayoutDecorator.getGraph() |
protected Graph |
AbstractLayout.getVisibleGraph()
Accessor for the graph that represets all visible vertices.
|
Modifier and Type | Method and Description |
---|---|
void |
AbstractLayout.applyFilter(Graph g)
Applies the filter to the current graph.
|
void |
FadingVertexLayout.applyFilter(Graph g_int)
Deprecated.
Tracks the changes in the set of visible vertices from the set of
actual vertices.
|
void |
Layout.applyFilter(Graph subgraph)
Sets this filtered graph to be the applicable graph.
|
void |
LayoutDecorator.applyFilter(Graph subgraph) |
Constructor and Description |
---|
AbstractLayout(Graph g)
Constructor.
|
FRLayout(Graph g) |
GraphDraw(Graph g)
Deprecated.
Creates a graph drawing environment that draws this graph object.
|
ISOMLayout(Graph g) |
SpringLayout(Graph g)
Constructor for a SpringLayout for a raw graph with associated
dimension--the input knows how big the graph is.
|
SpringLayout(Graph g,
SpringLayout.LengthFunction f)
Constructor for a SpringLayout for a raw graph with associated component.
|
StaticLayout(Graph g) |
Modifier and Type | Method and Description |
---|---|
void |
TreeLayout.applyFilter(Graph g) |
static void |
DAGLayout.setRoot(Graph g)
setRoot calculates the level of each vertex in the graph.
|
Constructor and Description |
---|
CircleLayout(Graph g) |
DAGLayout(Graph g) |
KKLayout(Graph g) |
KKLayout(Graph g,
Distance distance) |
KKLayoutInt(Graph g) |
Modifier and Type | Field and Description |
---|---|
protected static Graph[] |
ShowLayouts.g_array |
Modifier and Type | Method and Description |
---|---|
Graph |
PluggableRendererDemo.getGraph()
Generates a mixed-mode random graph, runs VoltageRanker on it, and
returns the resultant graph.
|
static Graph |
SimpleGraphDraw.getGraph()
Generates a graph: in this case, reads it from the file
"samples/datasetsgraph/simple.net"
|
Modifier and Type | Method and Description |
---|---|
protected void |
RankingDemo.displayGraph(Graph graph) |
protected void |
RankingDemo.recalculate(Graph graph,
Vertex startingVertex,
boolean fixAxes) |
Constructor and Description |
---|
RankingDemo(Graph g) |
ShortestPathDemo(Graph g) |
Modifier and Type | Method and Description |
---|---|
StaticLayout |
StaticLayout.initializeLocations(java.awt.Dimension d,
Graph g) |
Modifier and Type | Method and Description |
---|---|
void |
GraphLayoutPanel.updateGraphToMatch(Graph g) |
Constructor and Description |
---|
GraphLayoutPanel(Graph g,
java.awt.Dimension d,
VertexRenderer vr,
EdgeRenderer er)
Creates a GraphLayout panel.
|
Modifier and Type | Method and Description |
---|---|
protected void |
UpdatableIterableLayout.cleanupReferences(Graph g)
This OPTIONAL OPTIMIZATION allows the java garbage collector to work.
|
void |
LocalGraphDraw.updateGraphTo(Graph g) |
void |
UpdatableIterableLayout.updateGraphToMatch(Graph g)
Updates the stored set of of vertices and edges to match the input
graph.
|
Constructor and Description |
---|
LocalGraphDraw(Graph g,
StaticLayout startup,
IterableLayout layout,
VertexRenderer vr,
EdgeRenderer er,
java.awt.Dimension d,
boolean prerelax)
A verbose constructor creates a LocalGraphDraw object, and a panel to
show.
|
LocalGraphDraw(Graph g,
StaticLayout startup,
VertexRenderer vr,
EdgeRenderer er,
java.awt.Dimension d)
A LocalGraphDraw that won't be animated.
|
Modifier and Type | Method and Description |
---|---|
StaticLayout |
CircleLayout.initializeLocations(java.awt.Dimension d,
Graph g) |
StaticLayout |
IterableFromStaticEmittedLayout.initializeLocations(java.awt.Dimension d,
Graph g) |
StaticLayout |
IterableToStaticLayout.initializeLocations(java.awt.Dimension d,
Graph g) |
Modifier and Type | Method and Description |
---|---|
static void |
QuickDraw.quickDraw(Graph g)
Draws a graph quickly with its default StringLabeller (or nothing) and
the SettableRenderer with the "light" style.
|
static void |
QuickDraw.quickDraw(Graph g,
StringLabeller sl)
Draws a graph quickly with the given StringLabeller and the
SettableRenderer with the "light" style.
|
static void |
QuickDraw.quickDrawWithToString(Graph g)
Draws a graph quickly with a ToString labeller and the SettableRenderer
with the "light" style.
|
Constructor and Description |
---|
LazySparseVertexFactory(Graph g) |
LazyWebCrawler.WebCrawlerFactory(Graph g) |
Modifier and Type | Method and Description |
---|---|
Graph |
CircleLayout.getGraph() |
Modifier and Type | Method and Description |
---|---|
void |
CircleLayout.applyFilter(Graph g) |
protected static void |
BetweenVis.runFilter(Graph g,
FadeBetweennessRenderer r,
Layout v,
NumericDecorationFilter f2,
Filter ff) |
protected static void |
TestVis.runFilter(Graph g,
FadeBetweennessRenderer r,
Layout v,
WeightedEdgeGraphFilter f2,
Filter ff,
javax.swing.JSlider strength) |
Constructor and Description |
---|
CircleLayout(Graph g)
Constructor for a SpringVisualizer for a raw graph with associated
dimension--the input knows how big the graph is.
|
Constructor and Description |
---|
EigenvectorCentralityRanker(Graph g,
int max_iterations,
double tolerance) |
EigenvectorCentralityRanker(Graph g,
NumberEdgeValue edge_value,
int max_iterations,
double tolerance) |
EigenvectorCentralityRanker(Graph g,
NumberVertexValue priors,
NumberEdgeValue edge_value,
int max_iterations,
double tolerance) |
HITSRanker(Graph g,
int max_iterations,
double tolerance) |
HITSRanker(Graph g,
NumberEdgeValue edge_value,
int max_iterations,
double tolerance) |
PageRankRanker(Graph g,
int max_iterations,
double tolerance,
double alpha) |
PageRankRanker(Graph g,
NumberEdgeValue edge_value,
int max_iterations,
double tolerance,
double alpha) |
PageRankRanker(Graph g,
NumberVertexValue priors,
NumberEdgeValue edge_value,
int max_iterations,
double tolerance,
double alpha) |
WeightedDegreeRanker(Graph g) |
WeightedDegreeRanker(Graph g,
boolean normalized) |
WeightedDegreeRanker(Graph g,
NumberEdgeValue edge_weights) |
WeightedDegreeRanker(Graph g,
NumberEdgeValue edge_weights,
boolean normalized) |
Modifier and Type | Method and Description |
---|---|
protected static Graph |
UserExample.constructGraph(double td,
cern.colt.matrix.DoubleMatrix2D m) |
Graph |
AestheticSpringVisualizer.getGraph() |
Modifier and Type | Method and Description |
---|---|
void |
AestheticSpringVisualizer.applyFilter(Graph subgraph) |
protected void |
BrandesBetweennessCentrality.computeBetweenness(Graph graph) |
protected void |
NewmanBetweennessCentrality.computeBetweenness(Graph graph) |
protected void |
VizApp.displayGraph(Graph graph) |
Constructor and Description |
---|
AestheticSpringVisualizer(Graph g)
Constructor for a SpringVisualizer for a raw graph with associated
dimension--the input knows how big the graph is.
|
AestheticSpringVisualizer(Graph g,
AestheticSpringVisualizer.LengthFunction f,
java.awt.Dimension d)
Constructor for a SpringVisualizer for a raw graph with
associated component.
|
AestheticSpringVisualizer(Graph g,
AestheticSpringVisualizer.LengthFunction f,
javax.swing.JComponent jc)
Constructor for a SpringVisualizer for a raw graph with
associated component.
|
AestheticSpringVisualizer(Graph g,
java.awt.Dimension d)
Constructor for a SpringVisualizer for a raw graph with associated
dimension--the input knows how big the graph is.
|
AestheticSpringVisualizer(Graph g,
javax.swing.JComponent jc)
Constructor for a SpringVisualizer for a raw graph with associated
component.
|
BrandesBetweennessCentrality(Graph g)
Constructor which initializes the algorithm
|
FastScalableMDS(Graph g) |
FastScalableMDSPrototype(Graph g,
int k) |
NewmanBetweennessCentrality(Graph g,
boolean rankNodes,
boolean rankEdges)
Constructor which initializes the algorithm
|
Modifier and Type | Method and Description |
---|---|
protected Graph |
UserDataRegistry.getGraph() |
Constructor and Description |
---|
EdgeRegistry(Graph graph) |
UserDataRegistry(Graph graph) |
VertexRegistry(Graph graph) |
Modifier and Type | Method and Description |
---|---|
protected void |
RankingDemo.displayGraph(Graph graph) |
Modifier and Type | Method and Description |
---|---|
abstract Graph |
TestWeakComponentClusterer.getGraph() |
Graph |
TestWeakComponentClusterer.TestDirected.getGraph() |
Graph |
TestWeakComponentClusterer.TestUndirected.getGraph() |
Modifier and Type | Method and Description |
---|---|
void |
TestBicomponentClusterer.createEdges(Vertex[] v,
int[][] edge_array,
Graph g) |
Vertex |
TestBicomponentClusterer.getVertex(Vertex[] v_array,
int i,
Graph g) |
Vertex[] |
TestBicomponentClusterer.getVerticesByLabel(Graph graph,
StringLabeller sl) |
void |
TestBicomponentClusterer.testComponents(Graph graph,
Vertex[] vertices,
java.util.Set[] c,
StringLabeller sl) |
Modifier and Type | Field and Description |
---|---|
protected Graph |
VoltageRankerTest.g |
Modifier and Type | Method and Description |
---|---|
void |
TestShortestPath.addEdges(Graph g,
Edge[] edge_array) |
void |
TestShortestPath.exceptionTest(Graph g,
int index) |
Modifier and Type | Method and Description |
---|---|
protected void |
BasicGraphTest.testGraph(Graph sag,
int edges,
int vertices) |
Modifier and Type | Method and Description |
---|---|
Graph |
CliquePredicateTest.makeKClique(int k,
boolean selfLoop) |
Modifier and Type | Method and Description |
---|---|
protected abstract Layout |
LayoutTester.getLayout(Graph g) |
protected Layout |
TestFRLayout.getLayout(Graph g) |
protected Layout |
TestSpringLayout.getLayout(Graph g) |