Uses of Interface
edu.uci.ics.jung.graph.Graph

Packages that use Graph
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   
 

Uses of Graph in edu.uci.ics.jung.algorithms
 

Methods in edu.uci.ics.jung.algorithms that return 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.
static Graph GraphMatrixOperations.matrixToGraph(DoubleMatrix2D matrix, NumberEdgeValue nev)
          Creates a graph from a square (weighted) adjacency matrix.
static Graph GraphMatrixOperations.matrixToGraph(DoubleMatrix2D matrix, String weightKey)
          Creates a graph from a square (weighted) adjacency matrix.
static Graph GraphMatrixOperations.matrixToGraph(DoubleMatrix2D matrix)
          Creates a graph from a square (weighted) adjacency matrix.
 

Methods in edu.uci.ics.jung.algorithms with parameters of type 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.
static SparseDoubleMatrix2D GraphMatrixOperations.graphToSparseMatrix(Graph g, Object edgeWeightKey)
          Returns a SparseDoubleMatrix2D which represents the edge weights of the input Graph.
static SparseDoubleMatrix2D GraphMatrixOperations.graphToSparseMatrix(Graph g)
           
static 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 SparseDoubleMatrix2D GraphMatrixOperations.createVertexDegreeDiagonalMatrix(Graph G)
          Returns a diagonal matrix whose diagonal entries contain the degree for the corresponding node.
static DoubleMatrix2D GraphMatrixOperations.computeMeanFirstPassageMatrix(Graph G, Object edgeWeightKey, DoubleMatrix1D stationaryDistribution)
          Computes the all-pairs mean first passage time for the specified graph, given an existing stationary probability distribution.
 

Uses of Graph in edu.uci.ics.jung.algorithms.blockmodel
 

Methods in edu.uci.ics.jung.algorithms.blockmodel that return Graph
 Graph EquivalenceRelation.getGraph()
          Returns the common graph to which all the vertices belong
 Graph GraphCollapser.getCollapsedGraph(EquivalenceRelation equivalence)
          This version collects sets of vertices in an equivalence relation into a single CollapsedVertex.
 Graph GraphCollapser.getCollapsedGraph(Graph g, Set rootSet)
          This function collapses a series of vertices in one EquivalenceSet into one CollapsedVertex.
 

Methods in edu.uci.ics.jung.algorithms.blockmodel with parameters of type Graph
protected  void BipartiteGraphCollapser.createUndirectedEdge(Graph g, GraphCollapser.CollapsedVertex superVertex, Vertex opposite, Set relevantEdges)
           
protected  GraphCollapser.CollapsedVertex BipartiteGraphCollapser.createCollapsedVertex(Graph g, Set rootSet)
          It must be the case that all members of rootSet are in the same partition.
 EquivalenceRelation EquivalenceAlgorithm.getEquivalences(Graph g)
          Runs the equivalence algorithm on the given graph, and returns an equivalence relation.
protected  void GraphCollapser.createEdgesCorrespondingToMap(Graph copy, GraphCollapser.CollapsedVertex cv, MultiMap vertices_to_edges, Set coveredCV)
          INTERNAL METHOD
protected  void GraphCollapser.replaceEquivalencesWithCollapsedVertices(EquivalenceRelation er, Graph copy, Map superVertices)
          INTERNAL (undocumented) method.
 Graph GraphCollapser.getCollapsedGraph(Graph g, Set rootSet)
          This function collapses a series of vertices in one EquivalenceSet into one CollapsedVertex.
protected  GraphCollapser.CollapsedVertex GraphCollapser.createCollapsedVertex(Graph g, Set rootSet)
          Overridable method to create a single vertex representing a set of vertices in the graph.
protected  void GraphCollapser.createUndirectedEdge(Graph g, GraphCollapser.CollapsedVertex superVertex, Vertex opposite, Set relevantEdges)
          Overridable method to create a single undirected edge that represents the data in its parameters.
protected  void GraphCollapser.createDirectedEdges(Graph graph, GraphCollapser.CollapsedVertex superVertex, Vertex opposite, Set relevantEdges)
          Overridable method to create a up to two directed edges that represents the data in its parameters.
 EquivalenceRelation StructurallyEquivalent.getEquivalences(Graph g)
           
protected  EquivalenceRelation StructurallyEquivalent.createEquivalenceClasses(Graph g, 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.
 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.
 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.
 

Constructors in edu.uci.ics.jung.algorithms.blockmodel with parameters of type Graph
EquivalenceRelation(Set rv, Graph g)
          Input is the basic data structure underneath: a Set of Sets.
 

Uses of Graph in edu.uci.ics.jung.algorithms.cluster
 

Methods in edu.uci.ics.jung.algorithms.cluster that return Graph
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
 

Methods in edu.uci.ics.jung.algorithms.cluster with parameters of type Graph
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
 

Constructors in edu.uci.ics.jung.algorithms.cluster with parameters of type Graph
EdgeClusterSet(Graph underlyingGraph)
          Constructs and initializes the set
 

Uses of Graph in edu.uci.ics.jung.algorithms.connectivity
 

Methods in edu.uci.ics.jung.algorithms.connectivity that return Graph
static Graph KNeighborhoodExtractor.extractNeighborhood(Graph graph, 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, Set rootNodes, int radiusK)
          Extracts the subgraph comprised of all vertices within distance K (out-directed) from any node in rootNodes.
static Graph KNeighborhoodExtractor.extractInDirectedNeighborhood(DirectedGraph graph, Set rootNodes, int radiusK)
          Extracts the subgraph comprised of all vertices within distance K (in-directed) from any node in rootNodes.
 

Methods in edu.uci.ics.jung.algorithms.connectivity with parameters of type Graph
 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, Set rootSet)
           
 void BFSDistanceLabeler.removeDecorations(Graph g)
           
 void BFSDistanceLabeler.labelDistances(Graph graph, 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.
static Graph KNeighborhoodExtractor.extractNeighborhood(Graph graph, Set rootNodes, int radiusK)
          Extracts the subgraph comprised of all vertices within distance K (undirected) from any node in rootNodes.
 

Uses of Graph in edu.uci.ics.jung.algorithms.importance
 

Methods in edu.uci.ics.jung.algorithms.importance that return Graph
protected  Graph AbstractRanker.getGraph()
           
 

Methods in edu.uci.ics.jung.algorithms.importance with parameters of type Graph
protected  void AbstractRanker.initialize(Graph graph, boolean isNodeRanker, boolean isEdgeRanker)
           
protected  void BetweennessCentrality.computeBetweenness(Graph graph)
           
protected  void HITS.initialize(Graph g)
           
protected  void HITSWithPriors.initialize(Graph g, String edgeWeightKeyName)
           
 void VoltageRanker.calculateVoltages(Graph g, Set sources, Set sinks)
          Calculates the voltages for g based on assigning each of the vertices in source a voltage of 1 V.
 void VoltageRanker.calculateVoltages(Graph g, Map source_voltages, Set sinks)
          Calculates the voltages for g based on the specified source and sink vertex sets.
 

Constructors in edu.uci.ics.jung.algorithms.importance with parameters of type Graph
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, 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.
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.
HITSWithPriors(Graph graph, double bias, 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.
HITSWithPriors(Graph graph, boolean useAuthorityForRanking, double bias, Set priors, String edgeWeightKey)
          More specialized constructor where the type of importance can be specified.
 

Uses of Graph in edu.uci.ics.jung.algorithms.shortestpath
 

Constructors in edu.uci.ics.jung.algorithms.shortestpath with parameters of type Graph
UnweightedShortestPath(Graph g)
          Constructs and initializes algorithm
 

Uses of Graph in edu.uci.ics.jung.algorithms.transformation
 

Methods in edu.uci.ics.jung.algorithms.transformation that return Graph
 Graph FoldingTransformer.fold(KPartiteGraph g, Predicate p)
          Equivalent to fold(g, p, null).
 Graph FoldingTransformer.fold(KPartiteGraph g, Predicate p, NumberEdgeValue nev)
           Converts g into a unipartite graph whose vertex set is the vertices whose partition is specified by p.
 Graph FoldingTransformer.fold(Hypergraph h, Graph target, boolean use_vertices, NumberEdgeValue nev, BidiMap map)
          Creates a Graph which is a "folded" version of h.
protected  Graph FoldingTransformer.createGraph()
          Returns a base graph to use.
 

Methods in edu.uci.ics.jung.algorithms.transformation with parameters of type 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.
protected static Map DirectionTransformer.convertVertices(Graph old, Graph transformed, boolean copy)
          Puts a version of each vertex from old into transformed.
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.
 Graph FoldingTransformer.fold(Hypergraph h, Graph target, boolean use_vertices, NumberEdgeValue nev, BidiMap map)
          Creates a Graph which is a "folded" version of h.
protected  void FoldingTransformer.addEdge(Graph newGraph, Vertex firstEnd, Element intermediate, Vertex secondEnd, NumberEdgeValue nev)
          Creates a new edge from firstEnd to secondEnd in newGraph.
 

Uses of Graph in edu.uci.ics.jung.graph
 

Subinterfaces of Graph in edu.uci.ics.jung.graph
 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.
 

Uses of Graph in edu.uci.ics.jung.graph.decorators
 

Fields in edu.uci.ics.jung.graph.decorators declared as Graph
protected  Graph StringLabeller.graph
           
 

Methods in edu.uci.ics.jung.graph.decorators that return Graph
 Graph EdgeWeightLabeller.getGraph()
          Returns the graph associated with this particular labeller.
 Graph StringLabeller.getGraph()
          Gets the graph associated with this StringLabeller
 

Methods in edu.uci.ics.jung.graph.decorators with parameters of type Graph
static EdgeWeightLabeller EdgeWeightLabeller.getLabeller(Graph g)
          Finds or creates an edge labeller for the graph, using the default user data key.
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, Object key)
          Checks an edge labeleller for the graph at the given key.
static EdgeWeightLabeller EdgeWeightLabeller.getLabeller(Graph g, Object key)
          Finds or creates an edge labeleller for the graph, using the given userdata key.
static StringLabeller GlobalStringLabeller.setLabellerTo(Graph g, Object key)
          Sets the StringLabeller of this graph, at this key, to be a ToStringLabeller.
static StringLabeller GlobalStringLabeller.getLabeller(Graph g)
           
static StringLabeller GlobalStringLabeller.setLabellerTo(Graph g)
          Sets the default StringLabeller of this graph to be a ToStringLabeller.
static boolean GlobalStringLabeller.hasStringLabeller(Graph g)
          Checks if a labeller--any labeller--is associated with this graph.
static boolean GlobalStringLabeller.hasStringLabeller(Graph g, Object key)
          Checks for a labeller attached to a particular key in the graph.
static StringLabeller StringLabeller.getLabeller(Graph g)
          Gets a labeller associated with this graph.
static boolean StringLabeller.hasStringLabeller(Graph g)
          Checks if a labeller is associated with this graph.
static boolean StringLabeller.hasStringLabeller(Graph g, Object key)
          Checks for a labeller attached to a particular key in the graph.
static StringLabeller StringLabeller.getLabeller(Graph g, Object key)
          Returns a labeller attached to a particular key in the graph.
static StringLabeller ToStringLabeller.setLabellerTo(Graph g, Object key)
          Sets the StringLabeller of this graph, at this key, to be a ToStringLabeller.
static StringLabeller ToStringLabeller.setLabellerTo(Graph g)
          Sets the default StringLabeller of this graph to be a ToStringLabeller.
 

Constructors in edu.uci.ics.jung.graph.decorators with parameters of type Graph
StringLabeller(Graph g)
           
ToStringLabeller(Graph g)
           
 

Uses of Graph in edu.uci.ics.jung.graph.filters
 

Fields in edu.uci.ics.jung.graph.filters declared as Graph
protected  Graph UnassembledGraph.originalGraph
           
 

Methods in edu.uci.ics.jung.graph.filters that return Graph
 Graph GraphAssemblyRecord.getOriginalGraph()
          Returns the original graph that created this subset.
 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 UnassembledGraph.getOriginalGraph()
          Returns the original graph that was subsetted for this UnsassembledGraph.
 Graph UnassembledGraph.assemble(boolean shouldPreserveRecord)
          Constructs a new graph based on the source graph.
 Graph UnassembledGraph.assemble()
           
 

Methods in edu.uci.ics.jung.graph.filters with parameters of type Graph
 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.
static GraphAssemblyRecord GraphAssemblyRecord.getAssemblyRecord(Graph g)
          Returns the GraphAssemblyRecord for a particular graph.
 UnassembledGraph SerialFilter.filter(Graph g)
          Runs through the sequence of filters, one at a time.
 

Constructors in edu.uci.ics.jung.graph.filters with parameters of type Graph
UnassembledGraph(Filter f, Set vertices, Set edges, Graph original)
           
UnassembledGraph(String name, Set vertices, Set edges, Graph original)
          A constructor that uses non-Filters (for example, GraphCluterers) to build themselves.
 

Uses of Graph in edu.uci.ics.jung.graph.filters.impl
 

Methods in edu.uci.ics.jung.graph.filters.impl with parameters of type Graph
 UnassembledGraph KNeighborhoodFilter.filter(Graph graph)
          Constructs an unassembled graph containing the k-neighbhood around the root node(s)
 

Uses of Graph in edu.uci.ics.jung.graph.impl
 

Classes in edu.uci.ics.jung.graph.impl that implement Graph
 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.
 

Methods in edu.uci.ics.jung.graph.impl that return Graph
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.
 

Constructors in edu.uci.ics.jung.graph.impl with parameters of type Graph
KPartiteSparseGraph(Graph g, Collection partitions, boolean subsets)
           Creates a new KPartiteSparseGraph which contains all the vertices and edges in g.
 

Uses of Graph in edu.uci.ics.jung.io
 

Methods in edu.uci.ics.jung.io that return Graph
 Graph GraphFile.load(String filename)
          Loads a graph from a file per the appropriate format
 Graph GraphMLFile.load(String filename)
          Loads a graph from a GraphML file.
 Graph GraphMLFile.load(InputStream stream)
          Deprecated. generally, InputStreams are less robust than Readers
 Graph GraphMLFile.load(Reader reader)
           
protected  Graph GraphMLFileHandler.getGraph()
           
 Graph MatrixFile.load(BufferedReader reader)
          Loads a graph from an input reader
 Graph MatrixFile.load(String filename)
           
 Graph PajekNetFile.load(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 PajekNetFile.load(Reader read)
          Deprecated. Loads a graph for the given BufferedReader (where the data is assumed to be in Pajek NET format).
 Graph PajekNetReader.load(String filename)
          Returns load(filename, new SparseGraph(), null).
 Graph PajekNetReader.load(String filename, NumberEdgeValue nev)
          Returns load(filename, new SparseGraph(), nev).
 Graph PajekNetReader.load(String filename, Graph g)
          Returns load(filename, g, null).
 Graph PajekNetReader.load(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(Reader reader, Graph g)
          Returns load(reader, g, null).
 Graph PajekNetReader.load(Reader reader, NumberEdgeValue nev)
          Returns load(reader, new SparseGraph(), nev).
 Graph PajekNetReader.load(Reader reader)
          Returns load(reader, new SparseGraph(), null).
 Graph PajekNetReader.load(Reader reader, Graph g, NumberEdgeValue nev)
          Returns load(reader, g, nev, new TypedVertexGenerator(g)).
 Graph PajekNetReader.load(Reader reader, Graph g, NumberEdgeValue nev, VertexGenerator vg)
          Populates the graph g with the graph represented by the Pajek-format data supplied by reader.
 

Methods in edu.uci.ics.jung.io with parameters of type Graph
 void GraphFile.save(Graph graph, String filename)
          Save a graph to disk per the appropriate format
 void GraphMLFile.save(Graph g, String filename)
           
 void GraphMLFile.save(Graph g, PrintStream out)
           
 void MatrixFile.save(Graph graph, String filename)
           
 void PajekNetFile.save(Graph graph, String filename)
          Deprecated. Writes graph to the file specified by filename in the Pajek NET format.
 Graph PajekNetReader.load(String filename, Graph g)
          Returns load(filename, g, null).
 Graph PajekNetReader.load(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(Reader reader, Graph g)
          Returns load(reader, g, null).
 Graph PajekNetReader.load(Reader reader, Graph g, NumberEdgeValue nev)
          Returns load(reader, g, nev, new TypedVertexGenerator(g)).
 Graph PajekNetReader.load(Reader reader, Graph g, NumberEdgeValue nev, VertexGenerator vg)
          Populates the graph g with the graph represented by the Pajek-format data supplied by reader.
protected  Edge PajekNetReader.createAddEdge(StringTokenizer st, Vertex v1, boolean directed, Graph g, Indexer id, boolean parallel_ok)
           
 void PajekNetWriter.save(Graph g, String filename, VertexStringer vs, NumberEdgeValue nev, VertexLocationFunction vld)
          Saves g to filename.
 void PajekNetWriter.save(Graph g, String filename, VertexStringer vs, NumberEdgeValue nev)
           
 void PajekNetWriter.save(Graph g, String filename)
          Saves g to filename; no vertex labels are written out, and the edge weights are written as 1.0.
 void PajekNetWriter.save(Graph 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 g, Writer w, VertexStringer vs, NumberEdgeValue nev)
           
 void PajekNetWriter.save(Graph graph, Writer w, VertexStringer vs, NumberEdgeValue nev, VertexLocationFunction vld)
          Writes graph to w.
static void PartitionDecorationReader.loadStrings(Graph bg, Reader name_reader, Predicate partition, Object string_key)
          Decorates vertices in the specified partition with strings.
static int PartitionDecorationReader.loadCounts(Graph bg, Reader count_reader, Predicate partition, Object count_key, UserDataContainer.CopyAction copyact)
          Decorates vertices in the specified partition with typed count data.
static void PartitionDecorationReader.loadCounts(Graph bg, Reader count_reader, Predicate partition, Object count_key, UserDataContainer.CopyAction copyact, int num_types)
           
 

Uses of Graph in edu.uci.ics.jung.random.generators
 

Methods in edu.uci.ics.jung.random.generators that return Graph
protected  Graph EppsteinPowerLawGenerator.initializeGraph()
           
 

Uses of Graph in edu.uci.ics.jung.random.permuters
 

Methods in edu.uci.ics.jung.random.permuters with parameters of type Graph
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 BernoulliEdgePermuter.permuteEdges(Graph graph, double probEdgeFlip)
          Permutes the edges using a user-specified probability that an edge is removed or added.
 void EdgePermuter.permuteEdges(Graph graph)
          Instructs the algoritm to go ahead and permute the edges for the given graph
 

Uses of Graph in edu.uci.ics.jung.utils
 

Methods in edu.uci.ics.jung.utils that return Graph
static Graph GraphUtils.vertexSetToGraph(Set s)
          Given a set of vertices, creates a new Graph that contains all of those vertices, and all the edges that connect them.
static Graph GraphUtils.edgeSetToGraph(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.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 TestGraphs.getOneComponentGraph()
          Returns a bigger, undirected test graph with a just one component.
static Graph TestGraphs.getDemoGraph()
          Returns a bigger test graph with a clique, several components, and other parts.
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.
 

Methods in edu.uci.ics.jung.utils with parameters of type Graph
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 boolean GraphProperties.containsSelfLoops(Graph g)
          Checks to see whether the graphs contains self-loops
static boolean GraphProperties.containsParallelEdges(Graph g)
          Checks to see whether the graphs contains parallel edges
static Edge GraphUtils.addEdge(Graph g, Vertex v1, Vertex v2)
          Adds an appropriate edge between two vertices.
static void GraphUtils.addVertices(Graph g, int count)
          Adds count vertices into a graph.
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 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 Set GraphUtils.translateAll(Set s, Graph g)
          Deprecated. As of version 1.4, replaced by GraphUtils.getEqualVertices(Set, ArchetypeGraph)
static Set GraphUtils.translateAllEdges(Set s, Graph g)
          Deprecated. As of version 1.4, replaced by GraphUtils.getEqualEdges(Set, ArchetypeGraph)
static DirectedGraph GraphUtils.transform(Graph uGraph)
          Deprecated. As of version 1.4, replaced by DirectionTransformer.toDirected(Graph)
static void GraphUtils.addVertices(Graph g, Set vertices)
          Adds all vertices in the specified set to g.
static void GraphUtils.addEdges(Graph g, Set edges)
          Adds all edges in the specified set to g.
static void GraphUtils.removeVertices(Graph g, Set vertices)
          Removes all vertices in the specified set from g.
static void GraphUtils.removeEdges(Graph g, Set edges)
          Removes all vertices in the specified set from g.
protected  Integer ParallelEdgeIndexSingleton.getIndex_internal(Edge e, Graph g)
           
static boolean PredicateUtils.enforcesDirected(Graph g)
          Returns true if g is constrained to only accept directed edges, and false otherwise.
static boolean PredicateUtils.enforcesUndirected(Graph g)
          Returns true if g is constrained to only accept undirected edges.
static boolean PredicateUtils.enforcesNotParallel(Graph g)
          Returns true if g is constrained to reject parallel edges.
 

Uses of Graph in edu.uci.ics.jung.visualization
 

Methods in edu.uci.ics.jung.visualization that return Graph
protected  Graph AbstractLayout.getVisibleGraph()
          Accessor for the graph that represets all visible vertices.
 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()
           
 

Methods in edu.uci.ics.jung.visualization with parameters of type Graph
 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)
           
 

Constructors in edu.uci.ics.jung.visualization with parameters of type Graph
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)
           
 

Uses of Graph in edu.uci.ics.jung.visualization.contrib
 

Methods in edu.uci.ics.jung.visualization.contrib with parameters of type Graph
static void DAGLayout.setRoot(Graph g)
          setRoot calculates the level of each vertex in the graph.
 void TreeLayout.applyFilter(Graph g)
           
 

Constructors in edu.uci.ics.jung.visualization.contrib with parameters of type Graph
CircleLayout(Graph g)
           
DAGLayout(Graph g)
           
KKLayout(Graph g)
           
KKLayout(Graph g, Distance distance)
           
KKLayoutInt(Graph g)
           
 

Uses of Graph in samples.graph
 

Fields in samples.graph declared as Graph
protected static Graph[] ShowLayouts.g_array
           
 

Methods in samples.graph that return Graph
 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"
 

Methods in samples.graph with parameters of type Graph
protected  void RankingDemo.displayGraph(Graph graph)
           
protected  void RankingDemo.recalculate(Graph graph, Vertex startingVertex, boolean fixAxes)
           
 

Constructors in samples.graph with parameters of type Graph
RankingDemo(Graph g)
           
ShortestPathDemo(Graph g)
           
 

Uses of Graph in samples.preview_new_graphdraw
 

Methods in samples.preview_new_graphdraw with parameters of type Graph
 StaticLayout StaticLayout.initializeLocations(Dimension d, Graph g)
           
 

Uses of Graph in samples.preview_new_graphdraw.impl
 

Methods in samples.preview_new_graphdraw.impl with parameters of type Graph
 void GraphLayoutPanel.updateGraphToMatch(Graph g)
           
 

Constructors in samples.preview_new_graphdraw.impl with parameters of type Graph
GraphLayoutPanel(Graph g, Dimension d, VertexRenderer vr, EdgeRenderer er)
          Creates a GraphLayout panel.
 

Uses of Graph in samples.preview_new_graphdraw.iter
 

Methods in samples.preview_new_graphdraw.iter with parameters of type Graph
 void LocalGraphDraw.updateGraphTo(Graph g)
           
 void UpdatableIterableLayout.updateGraphToMatch(Graph g)
          Updates the stored set of of vertices and edges to match the input graph.
protected  void UpdatableIterableLayout.cleanupReferences(Graph g)
          This OPTIONAL OPTIMIZATION allows the java garbage collector to work.
 

Constructors in samples.preview_new_graphdraw.iter with parameters of type Graph
LocalGraphDraw(Graph g, StaticLayout startup, IterableLayout layout, VertexRenderer vr, EdgeRenderer er, 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, Dimension d)
          A LocalGraphDraw that won't be animated.
 

Uses of Graph in samples.preview_new_graphdraw.staticlayouts
 

Methods in samples.preview_new_graphdraw.staticlayouts with parameters of type Graph
 StaticLayout CircleLayout.initializeLocations(Dimension d, Graph g)
           
 StaticLayout IterableFromStaticEmittedLayout.initializeLocations(Dimension d, Graph g)
           
 StaticLayout IterableToStaticLayout.initializeLocations(Dimension d, Graph g)