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

Packages that use Graph
Default Package   
edu.uci.ics.jung.algorithms   
edu.uci.ics.jung.algorithms.blockmodel   
edu.uci.ics.jung.algorithms.cluster   
edu.uci.ics.jung.algorithms.connectivity   
edu.uci.ics.jung.algorithms.importance   
edu.uci.ics.jung.algorithms.shortestpath   
edu.uci.ics.jung.algorithms.transformation   
edu.uci.ics.jung.graph   
edu.uci.ics.jung.graph.decorators   
edu.uci.ics.jung.graph.filters   
edu.uci.ics.jung.graph.filters.impl   
edu.uci.ics.jung.graph.impl   
edu.uci.ics.jung.random.permuters   
edu.uci.ics.jung.statistics   
edu.uci.ics.jung.utils   
edu.uci.ics.jung.visualization   
edu.uci.ics.jung.visualization.contrib   
org.civi.graph   
 

Uses of Graph in
 

Methods in Default Package that return Graph
 Graph CiviApplet.getGraph()
          Generates a graph: in this case, generates it from applet parameter.
 

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(cern.colt.matrix.DoubleMatrix2D matrix, java.lang.String weightKey)
          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 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 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.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.
 

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

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

Methods in edu.uci.ics.jung.algorithms.blockmodel with parameters of type Graph
 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.
 EquivalenceRelation StructurallyEquivalent.getEquivalences(Graph g)
           
 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.
 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.
 

Constructors in edu.uci.ics.jung.algorithms.blockmodel with parameters of type Graph
EquivalenceRelation(java.util.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
 Graph VertexClusterSet.getClusterAsNewSubGraph(int index)
          Constructs a new graph from the given cluster
 Graph EdgeClusterSet.getClusterAsNewSubGraph(int index)
          Constructs a new graph from the given cluster
abstract  Graph ClusterSet.getClusterAsNewSubGraph(int index)
          Constructs a new graph from the given cluster
 Graph ClusterSet.getUnderlyingGraph()
           
 

Methods in edu.uci.ics.jung.algorithms.cluster with parameters of type Graph
 ClusterSet WeakComponentClusterer.extract(Graph aGraph)
          Extracts the weak components from a 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
 ClusterSet GraphClusterer.extract(Graph graph)
          Extracts the clusters from a 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 EdgeBetweennessClusterer.extract(Graph graph)
          Finds the set of clusters which have the strongest "community structure".
abstract  ClusterSet ClusterSet.createEquivalentClusterSet(Graph anotherGraph)
          Returns the corresponding cluster set in the other graph.
 ClusterSet BicomponentClusterer.extract(Graph theGraph)
          Extracts the bicomponents from the graph
 

Constructors in edu.uci.ics.jung.algorithms.cluster with parameters of type Graph
VertexClusterSet(Graph underlyingGraph)
          Constructs and initializes the set
EdgeClusterSet(Graph underlyingGraph)
          Constructs and initializes the set
ClusterSet(Graph underlyingGraph)
          Creates a new instance.
 

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, 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.
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.
 

Methods in edu.uci.ics.jung.algorithms.connectivity with parameters of type Graph
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
 void BFSDistanceLabeler.removeDecorations(Graph g)
           
 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.
 

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

Constructors in edu.uci.ics.jung.algorithms.importance with parameters of type Graph
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.
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.
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.
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.
BetweennessCentrality(Graph g)
          Constructor which initializes the algorithm
BetweennessCentrality(Graph g, boolean rankNodes)
           
 

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
DijkstraShortestPath(Graph g, NumberEdgeValue nev, boolean cached)
          Creates an instance of DijkstraShortestPath for the specified graph and the specified method of extracting weights from edges.
DijkstraShortestPath(Graph g, NumberEdgeValue nev)
           
DijkstraShortestPath(Graph g)
           
 

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

Methods in edu.uci.ics.jung.algorithms.transformation that return Graph
 Graph KPartiteFolder.fold(KPartiteGraph g, org.apache.commons.collections.Predicate p)
           Converts g into a unipartite graph whose vertex set is the vertices whose partition is specified by p.
 

Methods in edu.uci.ics.jung.algorithms.transformation with parameters of type Graph
static UndirectedGraph DirectionTransformer.toUndirected(Graph dGraph)
          Transforms graph (which may be either directed or mixed) into an undirected graph without parallel edges.
static DirectedGraph DirectionTransformer.toDirected(Graph graph)
          Transforms graph (which may be either undirected or mixed) into a directed graph without parallel edges.
 

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
 

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

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

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

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

Methods in edu.uci.ics.jung.graph.filters with parameters of type 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.
 UnassembledGraph GeneralVertexAcceptFilter.filter(Graph g)
          This method does the actual filtering of the the graph.
 UnassembledGraph GeneralEdgeAcceptFilter.filter(Graph g)
          Returns an UnassembledGraph with the subset of edges that pass acceptEdge.
 UnassembledGraph Filter.filter(Graph g)
          Filters a graph by returning an UnassembledGraph consisting of nodes and edges that pass the filter.
 

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

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, java.util.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.random.permuters
 

Methods in edu.uci.ics.jung.random.permuters with parameters of type Graph
 void EdgePermuter.permuteEdges(Graph graph)
          Instructs the algoritm to go ahead and permute the edges for the given graph
 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.
 

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

Methods in edu.uci.ics.jung.statistics with parameters of type Graph
static cern.colt.list.DoubleArrayList GraphStatistics.averageDistances(Graph graph)
          The set of average shortest path distances for each vertex.
static int GraphStatistics.diameter(Graph g)
          Computes the diameter (maximum shortest path length between any vertex pair) of the graph, ignoring edge weights.
 

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

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

Methods in edu.uci.ics.jung.utils with parameters of type Graph
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.
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 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.getEqualVertices(Set, ArchetypeGraph)
static DirectedGraph GraphUtils.transform(Graph uGraph)
          Deprecated. As of version 1.4, replaced by edu.ics.uci.jung.algorithms.transformation.DirectionTransformer#toDirected(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, i.e. 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
 

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

Methods in edu.uci.ics.jung.visualization that return Graph
 Graph Layout.getGraph()
          Returns the full graph (the one that was passed in at construction time) that this Layout refers to.
 Graph FadingVertexLayout.getGraph()
          A pass-through.
 Graph AbstractLayout.getGraph()
          Accessor for the graph that represets all vertices.
 

Methods in edu.uci.ics.jung.visualization with parameters of type Graph
 void Layout.applyFilter(Graph subgraph)
          Sets this filtered graph to be the applicable graph.
 void FadingVertexLayout.applyFilter(Graph g_int)
          Tracks the changes in the set of visible vertices from the set of actual vertices.
 void AbstractLayout.applyFilter(Graph g)
          Applies the filter to the current graph.
 

Constructors in edu.uci.ics.jung.visualization with parameters of type Graph
SpringLayout(Graph g)
           
SpringLayout(Graph g, SpringLayout.LengthFunction f)
           
ISOMLayout(Graph g)
           
GraphDraw(Graph g)
          Creates a graph drawing environment that draws this graph object.
FRLayout(Graph g)
           
AbstractLayout(Graph g)
          Constructor.
 

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.
 

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

Uses of Graph in org.civi.graph
 

Methods in org.civi.graph that return Graph
 Graph GraphModeler.getGraph()