Skip navigation links
A B C D E F G H I K L M N O P R S T U V W Y 

A

AbstractDegreeAlgorithm - Class in grph.algo.degree
 
AbstractDegreeAlgorithm() - Constructor for class grph.algo.degree.AbstractDegreeAlgorithm
 
AbstractGraphOperation - Class in grph.script
 
AbstractGraphOperation(RegularFile) - Constructor for class grph.script.AbstractGraphOperation
 
AbstractGraphReader - Class in grph.io
 
AbstractGraphReader() - Constructor for class grph.io.AbstractGraphReader
 
AbstractGraphTextWriter - Class in grph.io
 
AbstractGraphTextWriter() - Constructor for class grph.io.AbstractGraphTextWriter
 
AbstractGraphWriter - Class in grph.io
 
AbstractGraphWriter() - Constructor for class grph.io.AbstractGraphWriter
 
AbstractGrphScript - Class in grph.script
 
AbstractGrphScript(RegularFile) - Constructor for class grph.script.AbstractGrphScript
 
AbstractPath - Class in grph.path
A abstraction of path.
AbstractPath() - Constructor for class grph.path.AbstractPath
 
AbstractStepper - Class in grph.stepper
This is the equivalent of the StepAlgo class in Mascopt.
AbstractStepper(Grph) - Constructor for class grph.stepper.AbstractStepper
 
AbstractStepper(Grph, boolean, boolean, boolean, boolean) - Constructor for class grph.stepper.AbstractStepper
 
acceptLoops() - Method in class grph.algo.topology.ErdosRenyiRandomizedScheme
 
acceptValue(T) - Method in class grph.properties.ObjectProperty
 
acceptValue(String) - Method in class grph.properties.StringProperty
 
actionPerformed(ActionEvent) - Method in class GrphApplet
 
add(int) - Method in class grph.in_memory.GrphIntSet
 
add(int, int) - Method in class grph.in_memory.IncidenceList
 
add_to_algorithm_repository - Class in grph.script
 
add_to_algorithm_repository(RegularFile) - Constructor for class grph.script.add_to_algorithm_repository
 
addBSCs(Grph, int, Random) - Static method in class grph.algo.topology.gsm.WirelessBackhaul
 
addColorClass(IntSet) - Method in class grph.algo.coloring.GraphColoring
Appends the specified color class to this coloring.
addDirectedHyperEdge(int) - Method in interface grph.DirectedHyperGraph
 
addDirectedHyperEdge(int) - Method in class grph.in_memory.InMemoryGrph
Adds the given directed hyper-edge.
addDirectedSimpleEdge(int, int, int) - Method in interface grph.DirectedSimpleGraph
 
addDirectedSimpleEdge(int, int) - Method in class grph.Grph
Adds an arc connecting the given source and destination vertices.
addDirectedSimpleEdge(int, int, int) - Method in class grph.in_memory.InMemoryGrph
Adds the given arc, connecting the given source and destination vertices.
addDirectedSimpleEdge(V, E, V) - Method in class grph.oo.ObjectGrph
 
addFile(String, byte[]) - Method in class grph.report.LatexDocument
 
addGraph(Grph) - Method in class grph.Grph
 
addHyperEdge(int, int...) - Method in class grph.Grph
 
addNVertices(int) - Method in class grph.Grph
Creates n vertices in this graph.
addSimpleEdge(int, int, boolean) - Method in class grph.Grph
Connects the given vertices with a simple edge created on-the-fly.
addSimpleEdge(int, int, int, boolean) - Method in class grph.Grph
Connects the given vertices with the given simple edge.
addSimpleEdge(V, E, V, boolean) - Method in class grph.oo.ObjectGrph
 
addToDirectedHyperEdgeHead(int, int) - Method in interface grph.DirectedHyperGraph
 
addToDirectedHyperEdgeHead(int, int) - Method in class grph.in_memory.InMemoryGrph
 
addToDirectedHyperEdgeTail(int, int) - Method in interface grph.DirectedHyperGraph
 
addToDirectedHyperEdgeTail(int, int) - Method in class grph.in_memory.InMemoryGrph
 
addToUndirectedHyperEdge(int, int) - Method in class grph.in_memory.InMemoryGrph
Adds the given vertex to the given hyper-edge.
addToUndirectedHyperEdge(int, int) - Method in interface grph.UndirectedHyperGraph
 
addTrees(Grph, int, int, int, Random) - Static method in class grph.algo.topology.gsm.TreeOfRingsWirelessBackhaul
 
addUndirectedHyperEdge(int) - Method in class grph.in_memory.InMemoryGrph
Adds the given undirected hyper-edge to this graph.
addUndirectedHyperEdge(int) - Method in interface grph.UndirectedHyperGraph
 
addUndirectedSimpleEdge(int, int) - Method in class grph.Grph
Adds an edge connecting the two given vertices.
addUndirectedSimpleEdge(int, int, int) - Method in class grph.in_memory.InMemoryGrph
Adds the given edge connecting the two given vertices.
addUndirectedSimpleEdge(V, E, V) - Method in class grph.oo.ObjectGrph
 
addUndirectedSimpleEdge(int, int, int) - Method in interface grph.UndirectedSimpleGraph
 
addVertex() - Method in class grph.Grph
Creates a new vertex in the graph.
addVertex(int) - Method in class grph.in_memory.InMemoryGrph
 
addVertex(V) - Method in class grph.oo.ObjectGrph
 
addVertex(int) - Method in interface grph.VertexSet
 
addVertexToClass(int, int) - Method in class grph.algo.coloring.GraphColoring
Appends the specified vertex of the specified color class.
addVertices(IntSet) - Method in class grph.Grph
 
AdjacencyMatrix - Class in grph.algo
A class that implements the notion of adjacency matrix of a graph.
AdjacencyMatrix(Grph) - Constructor for class grph.algo.AdjacencyMatrix
 
adjacencyMatrixAlgo - Variable in class grph.Grph
 
AdjacencyMatrixAlgorithm - Class in grph.algo
Computes the adjacency matrix for the given graph.
AdjacencyMatrixAlgorithm() - Constructor for class grph.algo.AdjacencyMatrixAlgorithm
 
ADJBinaryWriter - Class in grph.io
http://www.fim.uni-passau.de/en/fim/faculty/chairs/theoretische-informatik/projects.html
ADJBinaryWriter() - Constructor for class grph.io.ADJBinaryWriter
 
ADJTextReader - Class in grph.io
 
ADJTextReader() - Constructor for class grph.io.ADJTextReader
 
ADJTextWriter - Class in grph.io
http://www.fim.uni-passau.de/en/fim/faculty/chairs/theoretische-informatik/projects.html
ADJTextWriter() - Constructor for class grph.io.ADJTextWriter
 
AllClusteringCoefficientsAlgorithm - Class in grph.algo.clustering
Computes the clustering coefficients for all vertices in parallel.
AllClusteringCoefficientsAlgorithm() - Constructor for class grph.algo.clustering.AllClusteringCoefficientsAlgorithm
 
allClusteringCoefficientsAlgorithm - Variable in class grph.Grph
 
AllInEdgeDegreeAlgorithm - Class in grph.algo.degree
 
AllInEdgeDegreeAlgorithm() - Constructor for class grph.algo.degree.AllInEdgeDegreeAlgorithm
 
allowsMultipleEdges() - Method in class grph.io.EdgeListReader
 
AllPaths - Class in grph.algo
 
AllPaths() - Constructor for class grph.algo.AllPaths
 
allSourceRandomWalks(int, boolean) - Method in class grph.algo.distance.PageRank
Performs random walks of the given length, starting from every vertex in the graph.
alterGraph(Grph, InputStream, boolean, boolean, NumericalProperty) - Static method in class grph.io.EdgeListReader
 
AntCliqueAlgorithm - Class in grph.algo
Compute the maximum clique in the graph, using a ant-based heuristic.
AntCliqueAlgorithm() - Constructor for class grph.algo.AntCliqueAlgorithm
 
AntiGraphAlgorithm - Class in grph.algo
Tests if the given graph is an anti-graph
AntiGraphAlgorithm() - Constructor for class grph.algo.AntiGraphAlgorithm
 
apply(IntSet) - Method in class grph.dynamics.DynamicsModel
 
apply(int) - Method in class grph.dynamics.DynamicsModel
 
areEdgesAdjacent(int, int) - Method in class grph.Grph
 
areIsomorphic(Grph, Grph) - Static method in class grph.algo.DreadnautAlgorithm
 
areIsomorphic(Grph, Grph, boolean) - Static method in class grph.algo.DreadnautAlgorithm
 
areVerticesAdjacent(int, int) - Method in class grph.Grph
Checks if the given two vertices are connected.
ArrayListPath - Class in grph.path
 
ArrayListPath() - Constructor for class grph.path.ArrayListPath
 
ArrayPath - Class in grph.path
 
ArrayPath(int...) - Constructor for class grph.path.ArrayPath
 
Assertions - Class in grph.demo
 
Assertions() - Constructor for class grph.demo.Assertions
 
AsymmetricTopologyGenerator - Class in grph.algo.topology
For every arc in the graph, creates the corresponding link in the other direction.
AsymmetricTopologyGenerator() - Constructor for class grph.algo.topology.AsymmetricTopologyGenerator
 
AverageDegreeAlgorithm - Class in grph.algo
Computes the average degree of the graph
AverageDegreeAlgorithm() - Constructor for class grph.algo.AverageDegreeAlgorithm
 
avgClusteringCoefficient - Variable in class grph.algo.triangles.latapi.Result
 
AvgClusteringCoefficientAlgorithm - Class in grph.algo.clustering
Computes the clustering coefficients for all vertices.
AvgClusteringCoefficientAlgorithm() - Constructor for class grph.algo.clustering.AvgClusteringCoefficientAlgorithm
 
avgClusteringCoefficientAlgorithm - Variable in class grph.Grph
 
avgDegreeAlgorithm - Variable in class grph.Grph
 

B

backingGrph - Variable in class grph.oo.ObjectGrph
 
BellmanFordAlgorithm - Class in grph.algo.search
 
BellmanFordAlgorithm(NumericalProperty) - Constructor for class grph.algo.search.BellmanFordAlgorithm
 
bfs(int) - Method in class grph.Grph
Performs a BFS from the given vertex.
bfs(LucIntSet) - Method in class grph.Grph
 
BFSAlgorithm - Class in grph.algo.search
 
BFSAlgorithm() - Constructor for class grph.algo.search.BFSAlgorithm
 
bfsAlgorithm - Variable in class grph.Grph
 
bfsList(int) - Method in class grph.Grph
 
BiconnectedComponents - Class in grph.algo
 
BiconnectedComponents() - Constructor for class grph.algo.BiconnectedComponents
 
biggest_graph_possible - Class in grph.script
 
biggest_graph_possible(RegularFile) - Constructor for class grph.script.biggest_graph_possible
 
BigGrid - Class in grph.demo.perf
 
BigGrid() - Constructor for class grph.demo.perf.BigGrid
 
bipartiteAlgorithm - Variable in class grph.Grph
 
BipartiteMaximumMatchingAlgorithm - Class in grph.algo.covering_packing
An algorithm to solve the maximum bipartite matching problem.
BipartiteMaximumMatchingAlgorithm() - Constructor for class grph.algo.covering_packing.BipartiteMaximumMatchingAlgorithm
 
BipartitenessAlgorithm - Class in grph.algo.coloring
Implementation of the bipartite testing algorithm.
BipartitenessAlgorithm() - Constructor for class grph.algo.coloring.BipartitenessAlgorithm
 
BooleanOGDFAlgorithm - Class in grph.algo.ogdf
 
BooleanOGDFAlgorithm() - Constructor for class grph.algo.ogdf.BooleanOGDFAlgorithm
 
BranchingMinimumVertexCoverAlgorithm - Class in grph.algo.covering_packing
 
BranchingMinimumVertexCoverAlgorithm() - Constructor for class grph.algo.covering_packing.BranchingMinimumVertexCoverAlgorithm
 
branchingMinimumVertexCoverAlgorithm - Variable in class grph.Grph
 
brite(Grph, int, BriteTopologyGenerator.ALGO) - Static method in class grph.algo.topology.BriteTopologyGenerator
 
BriteTopologyGenerator - Class in grph.algo.topology
Provides a bridge to the BRITE topology generator (http://www.cs.bu.edu/brite/).
BriteTopologyGenerator() - Constructor for class grph.algo.topology.BriteTopologyGenerator
 
BriteTopologyGenerator.ALGO - Enum in grph.algo.topology
 
BriteTopologyGenerator.BWDist - Enum in grph.algo.topology
 
BriteTopologyGenerator.GrowthType - Enum in grph.algo.topology
 
BriteTopologyGenerator.NODE_PLACEMENT - Enum in grph.algo.topology
 
BruteForceMinimumVertexCoverAlgorithm - Class in grph.algo.covering_packing
 
BruteForceMinimumVertexCoverAlgorithm() - Constructor for class grph.algo.covering_packing.BruteForceMinimumVertexCoverAlgorithm
 
bruteForceMinimumVertexCoverAlgorithm - Variable in class grph.Grph
 
BSC - Class in grph.algo.topology.gsm
 
BSC(int) - Constructor for class grph.algo.topology.gsm.BSC
 
BTS - Class in grph.algo.topology.gsm
 
BTS(BSC, int) - Constructor for class grph.algo.topology.gsm.BTS
 
BusTopologyGenerator - Class in grph.algo.topology
 
BusTopologyGenerator() - Constructor for class grph.algo.topology.BusTopologyGenerator
 

C

Cache - Class in grph
 
Cache(Grph) - Constructor for class grph.Cache
 
cacheResultForGraph(Grph) - Method in class grph.GrphAlgorithm
 
callBrite(String, Random) - Static method in class grph.algo.topology.BriteTopologyGenerator
 
centerAlgorithm - Variable in class grph.Grph
 
chain(Grph, boolean) - Static method in class grph.algo.topology.ChainTopologyGenerator
 
chain(boolean) - Method in class grph.Grph
Connect the vertices in this graph as chain.
ChainTopologyGenerator - Class in grph.algo.topology
Link the given nodes as a chain.
ChainTopologyGenerator() - Constructor for class grph.algo.topology.ChainTopologyGenerator
 
change(DynamicsModel<G>, DynamicsEvent<G>) - Method in interface grph.dynamics.DynamicsListener
 
change(int) - Method in class grph.dynamics.DynamicsModel
 
Cholesky - Class in grph.algo.sparse_cut
Compilation: javac Cholesky.java Execution: java Cholesky Compute Cholesky decomposition of symmetric positive definite matrix A = LL^T.
Cholesky() - Constructor for class grph.algo.sparse_cut.Cholesky
 
cholesky(double[][]) - Static method in class grph.algo.sparse_cut.Cholesky
 
chordalAlgo - Variable in class grph.Grph
 
chordalGraph(int, long) - Static method in class grph.algo.topology.ChordalTopologyGenerator
 
ChordalityTestAlgorithm - Class in grph.algo.structural
Computes if the graph is chordal
ChordalityTestAlgorithm() - Constructor for class grph.algo.structural.ChordalityTestAlgorithm
 
ChordalTopologyGenerator - Class in grph.algo.topology
3-chordal topology.
ChordalTopologyGenerator() - Constructor for class grph.algo.topology.ChordalTopologyGenerator
 
ClassicalGraphs - Class in grph.algo.topology
The Class ClassicalGraphs contains methods for easily obtaining classical graphs (paths, cycles, cliques, Petersen graph...)
clear() - Method in class grph.Grph
Clears this graph.
clear() - Method in class grph.in_memory.GrphIntSet
 
clearCache() - Method in class grph.Grph
Clears the cache for all algorithms that employs one.
clique(Grph, IntArrayList, boolean[][], IntArrayList) - Static method in class grph.algo.topology.ChordalTopologyGenerator
 
clique(int) - Method in class grph.algo.topology.ClassicalGraphs
 
clique() - Method in class grph.Grph
Connect all vertices in this graph as a clique.
clique(IntSet) - Method in class grph.Grph
Connect the given set of vertices as a clique.
Cliquer - Class in grph.algo.structural.cliquer
 
Cliquer() - Constructor for class grph.algo.structural.cliquer.Cliquer
 
clone() - Method in class grph.Grph
Computes a clone of this graph.
clone() - Method in class grph.path.AbstractPath
 
clone() - Method in class grph.path.ArrayListPath
 
clone() - Method in class grph.path.ArrayPath
 
clone() - Method in interface grph.path.Path
 
clone() - Method in class grph.path.PathExtender
 
clone(boolean) - Method in class grph.path.PathExtender
 
clone() - Method in class grph.path.SearchResultWrappedPath
 
clone() - Method in class grph.path.SingletonPath
 
cloneValuesTo(Property) - Method in class grph.properties.NumericalProperty
 
cloneValuesTo(Property) - Method in class grph.properties.ObjectProperty
 
cloneValuesTo(Property) - Method in class grph.properties.Property
 
Cluster - Class in grph.algo.clustering
 
Cluster(int) - Constructor for class grph.algo.clustering.Cluster
 
Clustering - Class in grph.algo.clustering
 
Clustering() - Constructor for class grph.algo.clustering.Clustering
 
ClusteringAlgorithm - Interface in grph.algo.clustering
 
ClusteringCoefficient - Class in grph.algo.clustering
 
ClusteringCoefficient() - Constructor for class grph.algo.clustering.ClusteringCoefficient
 
CMD - Static variable in class grph.algo.partitionning.metis.Gpmetis
 
cmd - Static variable in class grph.algo.structural.cliquer.Cliquer
 
ColorMap - Class in <Unnamed>
 
ColorMap() - Constructor for class ColorMap
 
ColorProperty - Class in grph.properties
 
ColorProperty(String) - Constructor for class grph.properties.ColorProperty
 
ColorProperty(String, ColorPalette) - Constructor for class grph.properties.ColorProperty
 
Colors - Class in grph.demo
 
Colors() - Constructor for class grph.demo.Colors
 
compareTo(EdgeProperty) - Method in class grph.algo.msp.EdgeProperty
 
COMPILATION_DIRECTORY - Static variable in class grph.Grph
 
compile(boolean, boolean) - Method in class grph.report.LatexDocument
 
ComplementAlgorithm - Class in grph.algo
Computes the complement (or inverse) of the given graph.
ComplementAlgorithm() - Constructor for class grph.algo.ComplementAlgorithm
 
complementAlgorithm - Variable in class grph.Grph
 
completeBipartiteGraph(int, int) - Static method in class grph.algo.topology.ClassicalGraphs
Constructs the complete bipartite graph Km,n.
completeGraph(int) - Static method in class grph.algo.topology.ClassicalGraphs
Constructs the complete graph (also known as clique) on n vertices, Kn.
CompletenessAlgorithm - Class in grph.algo.structural
 
CompletenessAlgorithm() - Constructor for class grph.algo.structural.CompletenessAlgorithm
 
completenessAlgorithm - Variable in class grph.Grph
 
compute(Grph) - Method in class grph.algo.AdjacencyMatrixAlgorithm
 
compute(Grph) - Method in class grph.algo.AllPaths
 
compute(Grph, int, int, boolean) - Static method in class grph.algo.AllPaths
 
compute(int, Grph, int, int, boolean) - Static method in class grph.algo.AllPaths
 
compute(Grph) - Method in class grph.algo.AntCliqueAlgorithm
 
compute(Grph) - Method in class grph.algo.AntiGraphAlgorithm
 
compute(Grph) - Method in class grph.algo.AverageDegreeAlgorithm
 
compute(Grph, int) - Method in class grph.algo.clustering.AllClusteringCoefficientsAlgorithm
 
compute(Grph) - Method in class grph.algo.clustering.AvgClusteringCoefficientAlgorithm
 
compute(Grph) - Method in class grph.algo.clustering.GlobalClusteringCoefficientAlgorithm
Computes the global clustering coefficient of this graph, defined as the number of triangles over the number of triplets (i.e.
compute(Grph) - Method in class grph.algo.coloring.BipartitenessAlgorithm
Implementation of the algorithm described above.
compute(Grph) - Method in class grph.algo.ComplementAlgorithm
 
compute(Grph) - Method in class grph.algo.ConnectedComponentsAlgorithm
 
compute(Grph) - Method in class grph.algo.covering_packing.BipartiteMaximumMatchingAlgorithm
Implementation of the algorithm described above.
compute(Grph) - Method in class grph.algo.covering_packing.BranchingMinimumVertexCoverAlgorithm
 
compute(Grph) - Method in class grph.algo.covering_packing.BruteForceMinimumVertexCoverAlgorithm
 
compute(Grph) - Method in class grph.algo.covering_packing.FominGrandoniKratschMaximumindependentSetAlgorithm
 
compute(Grph) - Method in class grph.algo.covering_packing.NiedermeierMinimumVertexCoverAlgorithm
 
compute(Grph) - Method in class grph.algo.degree.AbstractDegreeAlgorithm
 
compute(Grph, int) - Method in class grph.algo.degree.AllInEdgeDegreeAlgorithm
 
compute(Grph) - Method in class grph.algo.DensityAlgorithm
 
compute(Grph) - Method in class grph.algo.distance.DistanceMatrixBasedDiameterAlgorithm
 
compute(Grph, DistanceMatrix) - Static method in class grph.algo.distance.DistanceMatrixBasedDiameterAlgorithm
 
compute(Grph) - Method in class grph.algo.distance.FloydWarshallAlgorithm
 
compute(Grph) - Method in class grph.algo.distance.FourSweepIterativeFringeDiameterAlgorithm
 
compute(Grph) - Method in class grph.algo.distance.GirthAlgorithm
 
compute(Grph) - Method in class grph.algo.distance.MinimumEccentricityGraphCenter
 
compute() - Method in class grph.algo.distance.PageRank
Computes the page rank value for every vertex in the graph.
compute(Grph) - Method in class grph.algo.distance.StackBasedBellmanFordWeightedMatrixAlgorithm
 
compute(Grph) - Method in class grph.algo.distance.TwoSweepBFSDiameterApproximationAlgorithm
 
compute(Grph) - Method in class grph.algo.distance.TwoSweepsGraphCenter
 
compute(Grph) - Method in class grph.algo.distance.UnweightedDistanceMatrixAlgorithm
 
compute(Grph) - Method in class grph.algo.distance.UnweightedPredecessorMatrixAlgorithm
 
compute(Grph) - Method in class grph.algo.distance.WeightedPredecessorMatrixAlgorithm
 
compute(Grph) - Method in class grph.algo.FindAllTrianglesAlgorithm
 
compute(Grph) - Method in class grph.algo.InacessibleVerticesAlgorithm
 
compute(Grph) - Method in class grph.algo.IncidenceMatrixAlgorithm
 
compute(Grph) - Method in class grph.algo.IrreflexiveAlgorithm
 
compute(Grph) - Method in class grph.algo.IsCyclicAlgorithm
 
compute(Grph) - Method in class grph.algo.IsolatedVerticesAlgorithm
 
compute(Grph, int, int, int, NumericalProperty) - Method in class grph.algo.k_shortest_paths.DisjointKShortestPaths
 
compute(Grph, int, int, int, NumericalProperty) - Method in class grph.algo.k_shortest_paths.KShortestPathsAlgorithm
 
compute(Grph, int, int, int, NumericalProperty) - Method in class grph.algo.k_shortest_paths.RandomWalkBasedKShortestPaths
 
compute(Grph, int, int, int, NumericalProperty) - Method in class grph.algo.k_shortest_paths.YenTopKShortestPathsAlgorithm
 
compute(Grph) - Method in class grph.algo.labelling.GreedyChromaticNumber
Finds the number of colors required for a greedy coloring of the graph.
compute(Grph) - Method in class grph.algo.labelling.Relabelling
 
compute(Grph, Grph, List<Property>, boolean, List<Property>) - Static method in class grph.algo.LADBasedFullMatching
 
compute(Grph, Grph, boolean, boolean, List<Property>, List<Property>) - Static method in class grph.algo.LADBasedFullMatching
 
compute(Grph) - Method in class grph.algo.LineGraphAlgorithm
 
compute(Grph) - Method in class grph.algo.LPBasedAlgorithm
 
compute(Grph) - Method in class grph.algo.MatrixBasedNumberOfTrianglesAlgorithm
Computes the number of triangles in g (Note: the number of triangles in a graph equals the trace of A^3 / 6, where A is the adjacency matrix of the graph).
compute(Grph, int, int, NumericalProperty) - Method in class grph.algo.MaxFlowAlgorithm
 
compute(Grph, int, int, NumericalProperty, LPSolver) - Method in class grph.algo.MaxFlowAlgorithm
 
compute(Grph) - Method in class grph.algo.ogdf.OGDFAlgorithm
 
compute(Grph) - Method in class grph.algo.OutVertexAdjacencyAsIDSetsAlgorithm
 
compute(Grph, int, Random) - Method in class grph.algo.partitionning.metis.Gpmetis
 
compute(Grph, int, Gpmetis.Ptype, Gpmetis.Ctype, Gpmetis.Iptype, Gpmetis.Objtype, boolean, boolean, int, int, int, Random) - Method in class grph.algo.partitionning.metis.Gpmetis
 
compute(Grph) - Method in class grph.algo.RadiusAlgorithm
 
compute(Grph, int, Grph.DIRECTION, GraphSearchListener) - Method in class grph.algo.search.BellmanFordAlgorithm
 
compute(Grph, int, Grph.DIRECTION, GraphSearchListener) - Method in class grph.algo.search.DijkstraAlgorithm
 
compute(Grph) - Method in class grph.algo.search.DistanceListsBasedDiameterAlgorithm
 
compute(Grph) - Method in class grph.algo.search.SingleSourceSearchAlgorithm
 
compute(Grph, LucIntSet) - Method in class grph.algo.search.SingleSourceSearchAlgorithm
 
compute(Grph, Grph.DIRECTION, LucIntSet) - Method in class grph.algo.search.SingleSourceSearchAlgorithm
 
compute(Grph, int) - Method in class grph.algo.search.SingleSourceSearchAlgorithm
 
compute(Grph, int, GraphSearchListener) - Method in class grph.algo.search.SingleSourceSearchAlgorithm
 
compute(Grph, int, Grph.DIRECTION, GraphSearchListener) - Method in class grph.algo.search.SingleSourceSearchAlgorithm
 
compute(Grph, int, Grph.DIRECTION, GraphSearchListener) - Method in class grph.algo.search.StackBasedBellmanFordAlgorithm
 
compute(Grph, int, Grph.DIRECTION, GraphSearchListener) - Method in class grph.algo.search.TreeBasedTraversal
 
compute(Grph) - Method in class grph.algo.sparse_cut.SparseCutAlgorithm
 
compute(Grph) - Method in class grph.algo.StronglyConnectedComponentsAlgorithm
 
compute(Grph) - Method in class grph.algo.structural.ChordalityTestAlgorithm
 
compute(Grph, int, int, boolean) - Static method in class grph.algo.structural.cliquer.Cliquer
 
compute(Grph) - Method in class grph.algo.structural.cliquer.Cliquer
 
compute(Grph) - Method in class grph.algo.structural.cliquer.FindAllCliques
 
compute(Grph) - Method in class grph.algo.structural.CompletenessAlgorithm
 
compute(Grph) - Method in class grph.algo.structural.ConnectednessAlgorithm
 
compute(Grph) - Method in class grph.algo.structural.DiracTheorem
Are we sure the graph is hamiltonian?
compute(Grph) - Method in class grph.algo.structural.MultigraphnessAlgorithm
 
compute(Grph) - Method in class grph.algo.structural.OreTheorem
Are we sure the graph is hamiltonian?
compute(Grph) - Method in class grph.algo.structural.ReflexivityAlgorithm
 
compute(Grph) - Method in class grph.algo.structural.RegularityAlgorithm
 
compute(Grph) - Method in class grph.algo.structural.SimplenessAlgorithm
 
compute(Grph) - Method in class grph.algo.structural.TreenessAlgorithm
 
compute(Grph) - Method in class grph.algo.subgraph_isomorphism.own.FindAllCycles
 
compute(Grph, Grph, boolean) - Method in class grph.algo.subgraph_isomorphism.own.SubgraphSearch
 
compute(Grph, Grph, boolean, List<IntArrayList>, IntArrayList, int, boolean) - Method in class grph.algo.subgraph_isomorphism.own.SubgraphSearch
 
compute(Grph, Grph) - Method in class grph.algo.SubGraphIsomorphism4Julien
 
compute(Grph) - Method in class grph.algo.Tarjan
 
compute(Grph) - Method in class grph.algo.TopologicalSortingAlgorithm
 
compute(Grph) - Method in class grph.algo.topology.AsymmetricTopologyGenerator
 
compute(Grph) - Method in class grph.algo.topology.BriteTopologyGenerator
 
compute(Grph) - Method in class grph.algo.topology.BusTopologyGenerator
 
compute(Grph) - Method in class grph.algo.topology.ChainTopologyGenerator
 
compute(Grph) - Method in class grph.algo.topology.ChordalTopologyGenerator
 
compute(Grph) - Method in class grph.algo.topology.GLPIssamTopologyGenerator
 
compute(Grph, int, boolean) - Static method in class grph.algo.topology.GNMTopologyGenerator
 
compute(Grph) - Method in class grph.algo.topology.GNMTopologyGenerator
 
compute(Grph, double) - Static method in class grph.algo.topology.GNPTopologyGenerator
 
compute(Grph) - Method in class grph.algo.topology.GNPTopologyGenerator
 
compute(Grph, double, boolean, Random) - Static method in class grph.algo.topology.GNPTopologyGenerator
 
compute(Grph) - Method in class grph.algo.topology.GridTopologyGenerator
 
compute(Grph) - Method in class grph.algo.topology.InetTopologyGenerator
 
compute(Grph) - Method in class grph.algo.topology.KClosestNeighborsTopologyGenerator
 
compute(Grph, int) - Static method in class grph.algo.topology.KClosestNeighborsTopologyGenerator
 
compute(Grph) - Method in class grph.algo.topology.PlanarGraphTopologyGenerator
For every edge: - pick random in and out edge degree and connect it to random neighbors
compute(Grph) - Method in class grph.algo.topology.RandomizedGridTopology
 
compute(Grph) - Method in class grph.algo.topology.RandomNewmanWattsStrogatzTopologyGenerator
 
compute(Grph, int, double) - Static method in class grph.algo.topology.RandomNewmanWattsStrogatzTopologyGenerator
 
compute(Grph) - Method in class grph.algo.topology.RandomTreeTopologyGenerator
 
compute(Grph, int) - Static method in class grph.algo.topology.RandomTreeTopologyGenerator
 
compute(Grph) - Method in class grph.algo.topology.RingTopologyGenerator
 
compute(Grph) - Method in class grph.algo.topology.rmat.RmatTopologyGenerator
 
compute(Grph) - Method in class grph.algo.topology.StarTopologyGenerator
 
compute(Grph) - Method in interface grph.algo.topology.TopologyGenerator
 
compute(Grph) - Method in class grph.algo.triangles.latapi.MatthieuLatapyTriangleAlgorithm
 
compute(Grph) - Method in class grph.algo.VertexAdjacencyAlgorithm
 
compute(Grph) - Method in class grph.algo.VertexAdjacencyListsAlgorithm
 
compute(Grph) - Method in class grph.algo.VertexAlgorithm
 
compute(Grph, int) - Method in class grph.algo.VertexAlgorithm
 
compute(Grph) - Method in class grph.algo.VertexListAlgorithm
 
compute(Grph) - Method in class grph.algo.VertexSetAlgorithm
 
compute(Grph) - Method in class grph.GrphAlgorithm
 
compute(Grph) - Method in class grph.GrphAlgorithmCache
 
ComputeAllPairShortestPaths - Class in grph.demo
 
ComputeAllPairShortestPaths() - Constructor for class grph.demo.ComputeAllPairShortestPaths
 
computeAllPaths(Grph) - Static method in class grph.algo.AllPaths
 
computeArticulationPoints(Grph) - Static method in class grph.algo.BiconnectedComponents
 
computeBFSBasedSpanningTree(Grph) - Static method in class grph.algo.SpanningTree
 
computeBFSBasedSpanningTree(Grph, int, boolean) - Static method in class grph.algo.SpanningTree
 
computeBiconnectedComponents(Grph) - Static method in class grph.algo.BiconnectedComponents
 
computeClusters(Grph) - Method in interface grph.algo.clustering.ClusteringAlgorithm
 
computeClusters(Grph, int) - Method in class grph.algo.clustering.CONID
 
computeCutEdges(Grph) - Static method in class grph.algo.BiconnectedComponents
 
computeCutEdges(IntSet, Grph) - Static method in class grph.algo.BiconnectedComponents
 
ComputeDiameter - Class in grph.demo
 
ComputeDiameter() - Constructor for class grph.demo.ComputeDiameter
 
computeDistanceMatrix(Grph) - Method in class grph.algo.search.SingleSourceSearchAlgorithm
 
computeEdgeSet(IntSet) - Method in class grph.algo.labelling.Relabelling
 
computeFilename(Metric) - Method in interface grph.report.PropertyFilenameCalculator
 
computeKey(Object, Object...) - Method in class grph.Cache
 
computeMaxFlow(int, int, NumericalProperty) - Method in class grph.Grph
Computes the maximum flow from the given source to the given destination.
computeMinimalSpanningTree(Grph) - Method in interface grph.algo.SpanningTreeAlgorithm
 
computeMostAppropriateDrawingCommand(Grph) - Static method in class grph.io.GraphvizImageWriter
 
ComputeOneShortestPath - Class in grph.demo
 
ComputeOneShortestPath() - Constructor for class grph.demo.ComputeOneShortestPath
 
computePathTo(int) - Method in class grph.algo.search.SearchResult
 
computePDFReport() - Method in class grph.report.Report
 
computePDFReport(boolean, boolean, boolean) - Method in class grph.report.Report
 
computePredecessorMatrix(Grph) - Method in class grph.algo.search.SingleSourceSearchAlgorithm
 
computeResult(Grph) - Method in class grph.algo.LPBasedAlgorithm
 
computeTextualReport() - Method in class grph.report.Report
 
computeTransitiveClosure(Grph) - Static method in class grph.algo.TransitiveClosure
 
computeVertexSet(IntSet) - Method in class grph.algo.labelling.Relabelling
 
CONID - Class in grph.algo.clustering
 
CONID() - Constructor for class grph.algo.clustering.CONID
 
connectedComponentsAlg - Variable in class grph.Grph
 
ConnectedComponentsAlgorithm - Class in grph.algo
Computes the set of conected components in the graph.
ConnectedComponentsAlgorithm() - Constructor for class grph.algo.ConnectedComponentsAlgorithm
 
ConnectednessAlgorithm - Class in grph.algo.structural
 
ConnectednessAlgorithm() - Constructor for class grph.algo.structural.ConnectednessAlgorithm
 
connectednessAlgorithm - Variable in class grph.Grph
 
connectToKClosestNeighbors(int) - Method in class grph.Grph
Connect each vertex to its k-closest neighbours, according to the current topology.
console - Class in grph.script
 
console(RegularFile) - Constructor for class grph.script.console
 
ConsoleStepper - Class in grph.stepper
This is the equivalent of the StepAlgo class in Mascopt.
ConsoleStepper(Grph) - Constructor for class grph.stepper.ConsoleStepper
 
ConsoleStepper(Grph, boolean, boolean, boolean, boolean) - Constructor for class grph.stepper.ConsoleStepper
 
contains(Grph) - Method in class grph.Grph
Checks if this graph contains the given graph.
containsAPath(int, int) - Method in class grph.Grph
 
containsEdge(int) - Method in interface grph.EdgeSet
 
containsEdge(int) - Method in class grph.in_memory.InMemoryGrph
 
containsEdge(E) - Method in class grph.oo.ObjectGrph
 
containsVertex(int) - Method in class grph.in_memory.InMemoryGrph
 
containsVertex(V) - Method in class grph.oo.ObjectGrph
 
containsVertex(int) - Method in class grph.path.ArrayListPath
 
containsVertex(int) - Method in class grph.path.ArrayPath
 
containsVertex(int) - Method in interface grph.path.Path
 
containsVertex(int) - Method in class grph.path.PathExtender
 
containsVertex(int) - Method in class grph.path.SearchResultWrappedPath
 
containsVertex(int) - Method in class grph.path.SingletonPath
 
containsVertex(int) - Method in interface grph.VertexSet
 
ContiguousLabelling - Class in grph.algo.labelling
Contiguous vertex/edge labelling.
ContiguousLabelling() - Constructor for class grph.algo.labelling.ContiguousLabelling
 
contractEdge(int) - Method in class grph.Grph
 
contractVertices(int, int) - Method in class grph.Grph
 
contractVertices(int, int, boolean) - Method in class grph.Grph
 
convert - Class in grph.script
 
convert(RegularFile) - Constructor for class grph.script.convert
 
createArray(int) - Method in class grph.algo.search.BellmanFordAlgorithm
 
createArray(int) - Method in class grph.algo.search.DijkstraAlgorithm
 
createArray(int) - Method in class grph.algo.search.SingleSourceSearchAlgorithm
 
createArray(int) - Method in class grph.algo.search.StackBasedBellmanFordAlgorithm
 
createArray(int) - Method in class grph.algo.search.TreeBasedTraversal
 
createBackhaulWithNVertices(Grph, int, Random, boolean) - Static method in class grph.algo.topology.gsm.TreeOfRingsWirelessBackhaul
 
createDirectedLinks() - Method in class grph.algo.topology.ChainTopologyGenerator
 
createDirectedLinks(boolean) - Method in class grph.algo.topology.ChainTopologyGenerator
 
createDirectedLinks() - Method in class grph.algo.topology.GridTopologyGenerator
 
createDirectedLinks(boolean) - Method in class grph.algo.topology.GridTopologyGenerator
 
createDirectedLinks() - Method in class grph.algo.topology.RandomizedGridTopology
 
createDirectedLinks(boolean) - Method in class grph.algo.topology.RandomizedGridTopology
 
createDotText(Grph, boolean) - Method in class grph.io.DotWriter
 
createEmptySets(int) - Method in class grph.algo.partitionning.metis.Gpmetis
 
CreateGraph - Class in grph.demo
 
CreateGraph() - Constructor for class grph.demo.CreateGraph
 
createInputText(Grph) - Static method in class grph.algo.triangles.latapi.MatthieuLatapyTriangleAlgorithm
 
createModel(Grph) - Method in class grph.algo.topology.BriteTopologyGenerator
 
createNewChild(Population<Grph, Grph>, Random) - Method in class grph.topology.random.genetic.GraphCrossover
 
CreatePath - Class in grph.demo
 
CreatePath() - Constructor for class grph.demo.CreatePath
 
CreateRandomGraph - Class in grph.demo
 
CreateRandomGraph() - Constructor for class grph.demo.CreateRandomGraph
 
CreateRing - Class in grph.demo
 
CreateRing() - Constructor for class grph.demo.CreateRing
 
createRingsAndTrees(Grph, int, int, int, int, int, int, Random, boolean) - Static method in class grph.algo.topology.gsm.TreeOfRingsWirelessBackhaul
Creates both the tree of rings and the trees attached to it.
createRingsOnly(Grph, int, int, int, Random) - Static method in class grph.algo.topology.gsm.TreeOfRingsWirelessBackhaul
 
createsDirectedLinks() - Method in class grph.algo.topology.StarTopologyGenerator
 
createsDirectedLinks(boolean) - Method in class grph.algo.topology.StarTopologyGenerator
 
createSwingRenderer() - Method in class grph.Grph
 
createSwingRenderer(Grph) - Static method in class grph.gui.Swing
 
createTransitiveClosure(Grph) - Static method in class grph.algo.Roy_WarshallMethod
Create the transitive closure of the given graph.
cycle(int) - Static method in class grph.algo.topology.ClassicalGraphs
Constructs the cycle graph on n vertices, Cn.

D

d - Static variable in class grph.algo.structural.cliquer.Cliquer
 
David - Class in grph.demo
 
David() - Constructor for class grph.demo.David
 
defaultEdgeLabelling - Static variable in class grph.io.GraphvizImageWriter
 
DefaultIntSet - Class in grph
 
DefaultIntSet(int) - Constructor for class grph.DefaultIntSet
 
defaultNumberOfThreads - Static variable in class grph.algo.MultiThreadProcessing
 
defaultOutputFormat - Static variable in class grph.io.GraphvizImageWriter
 
degenerate(Grph, int, double) - Static method in class grph.algo.topology.gsm.WirelessBackhaul
Degenerates the given graph.
DegreeFilter(Grph, int, Grph.TYPE, Grph.DIRECTION) - Constructor for class grph.ElementFilter.DegreeFilter
 
Demo - Class in grph.algo.distance
 
Demo() - Constructor for class grph.algo.distance.Demo
 
Demo - Class in grph.algo.subgraph_isomorphism.own
 
Demo() - Constructor for class grph.algo.subgraph_isomorphism.own.Demo
 
Demo - Class in grph.topology.random.genetic
 
Demo() - Constructor for class grph.topology.random.genetic.Demo
 
demo_lifegame - Class in grph.script
 
demo_lifegame(RegularFile) - Constructor for class grph.script.demo_lifegame
 
DensityAlgorithm - Class in grph.algo
Computes the density of the graph.
DensityAlgorithm() - Constructor for class grph.algo.DensityAlgorithm
 
densityAlgorithm - Variable in class grph.Grph
 
destroy() - Method in class GrphApplet
 
detach() - Method in class grph.io.DynamicsLogger
 
DFSAlgorithm - Class in grph.algo.search
 
DFSAlgorithm() - Constructor for class grph.algo.search.DFSAlgorithm
 
dgrid(int, int) - Method in class grph.Grph
Connect vertices currently in the graph as a DIRECTED grid of dimension (w, h).
DGSWriter - Class in grph.io
 
DGSWriter() - Constructor for class grph.io.DGSWriter
 
diameterAlgorithm - Variable in class grph.Grph
 
DijkstraAlgorithm - Class in grph.algo.search
Computes the shortest paths in the graph, using the Dijkstra algorithm.
DijkstraAlgorithm(NumericalProperty) - Constructor for class grph.algo.search.DijkstraAlgorithm
 
DimacsReader - Class in grph.io
 
DimacsReader() - Constructor for class grph.io.DimacsReader
 
DimacsWriter - Class in grph.io
 
DimacsWriter() - Constructor for class grph.io.DimacsWriter
 
DiracTheorem - Class in grph.algo.structural
Dirac's theorem on Hamiltonian cycles, the statement that an n-vertex graph in which each vertex has degree at least n/2 must have a Hamiltonian cycle"; http://testard.frederic.pagesperso-orange.fr/mathematiques/coursGraphes/ chapitre02/cours/chapitre02_1.htm
DiracTheorem() - Constructor for class grph.algo.structural.DiracTheorem
 
DirectedGraph - Interface in grph
 
directedHyperEdgeAdded(Grph, int) - Method in class grph.gui.GraphRenderer
 
directedHyperEdgeAdded(Grph, int) - Method in class grph.gui.GraphvizComponent
 
directedHyperEdgeAdded(Grph, int) - Method in interface grph.TopologyListener
 
directedHyperEdgeRemoved(Grph, int, IntSet, IntSet) - Method in class grph.gui.GraphRenderer
 
directedHyperEdgeRemoved(Grph, int, IntSet, IntSet) - Method in class grph.gui.GraphvizComponent
 
directedHyperEdgeRemoved(Grph, int, IntSet, IntSet) - Method in interface grph.TopologyListener
 
DirectedHyperGraph - Interface in grph
 
DirectedLAD - Class in grph.algo.lad
LAD is a program (in C) for solving the subgraph isomorphism problem, the goal of which is to decide if there exists a copy of a pattern graph in a target graph.
DirectedLAD() - Constructor for class grph.algo.lad.DirectedLAD
 
DirectedLADWriter - Class in grph.algo.lad
 
DirectedLADWriter() - Constructor for class grph.algo.lad.DirectedLADWriter
 
directedSimpleEdgeAdded(Grph, int, int, int) - Method in class grph.gui.GraphRenderer
 
directedSimpleEdgeAdded(Grph, int, int, int) - Method in class grph.gui.GraphvizComponent
 
directedSimpleEdgeAdded(Grph, int, int, int) - Method in interface grph.TopologyListener
 
DirectedSimpleEdgeAdditionMutationOperator - Class in grph.topology.random.genetic
 
DirectedSimpleEdgeAdditionMutationOperator() - Constructor for class grph.topology.random.genetic.DirectedSimpleEdgeAdditionMutationOperator
 
directedSimpleEdgeRemoved(Grph, int, int, int) - Method in class grph.gui.GraphRenderer
 
directedSimpleEdgeRemoved(Grph, int, int, int) - Method in class grph.gui.GraphvizComponent
 
directedSimpleEdgeRemoved(Grph, int, int, int) - Method in interface grph.TopologyListener
 
DirectedSimpleGraph - Interface in grph
 
disconnect(int, int) - Method in class grph.Grph
Disconnect the two given vertices.
disconnectVertex(int) - Method in class grph.Grph
Disconnect the given vertex, i.e.
DisjointKShortestPaths - Class in grph.algo.k_shortest_paths
 
DisjointKShortestPaths() - Constructor for class grph.algo.k_shortest_paths.DisjointKShortestPaths
 
display(Grph) - Method in class grph.algo.MaxFlowAlgorithmResult
 
display() - Method in class grph.algo.topology.gsm.GSMNetwork
 
display() - Method in class grph.Grph
Display this graph in a graphical frame, using automatic layout.
display() - Method in class grph.gui.GraphstreamBasedRenderer
 
display() - Method in class grph.oo.ObjectGrph
 
display() - Method in class grph.report.Report
 
displayGraphstream_0_4_2() - Method in class grph.Grph
Display this graph in a graphical frame, using GraphStream 0.4.2.
displayImg() - Method in class grph.Grph
 
displayInAFrame() - Method in class grph.gui.GraphstreamBasedRenderer
 
displayReport() - Method in class grph.Grph
 
displaySVGSalamander() - Method in class grph.Grph
 
DistanceListsBasedDiameterAlgorithm - Class in grph.algo.search
compute the diameter via n*bfs without storing the matrices
DistanceListsBasedDiameterAlgorithm() - Constructor for class grph.algo.search.DistanceListsBasedDiameterAlgorithm
 
DistanceMatrix - Class in grph.algo.distance
A matrix of all distances in a graph.
DistanceMatrix(int, int) - Constructor for class grph.algo.distance.DistanceMatrix
 
DistanceMatrix(R[]) - Constructor for class grph.algo.distance.DistanceMatrix
 
DistanceMatrixAlgorithm - Class in grph.algo.distance
 
DistanceMatrixAlgorithm() - Constructor for class grph.algo.distance.DistanceMatrixAlgorithm
 
DistanceMatrixBasedDiameterAlgorithm - Class in grph.algo.distance
Computes the diameter of the graph.
DistanceMatrixBasedDiameterAlgorithm() - Constructor for class grph.algo.distance.DistanceMatrixBasedDiameterAlgorithm
 
distances - Variable in class grph.algo.search.SearchResult
 
DotWriter - Class in grph.io
 
DotWriter() - Constructor for class grph.io.DotWriter
 
DreadnautAlgorithm - Class in grph.algo
 
DreadnautAlgorithm() - Constructor for class grph.algo.DreadnautAlgorithm
 
dring() - Method in class grph.Grph
Creates a directed ring consisting of the vertices already in the graph.
DynamicGraph - Class in grph.demo
 
DynamicGraph() - Constructor for class grph.demo.DynamicGraph
 
DynamicsEvent<G extends Grph> - Class in grph.dynamics
 
DynamicsEvent(int, DynamicsModel<G>, DES<G>, double) - Constructor for class grph.dynamics.DynamicsEvent
 
DynamicsListener<G extends Grph> - Interface in grph.dynamics
 
DynamicsLogger - Class in grph.io
 
DynamicsLogger(Grph) - Constructor for class grph.io.DynamicsLogger
 
DynamicsLogger(Grph, PrintStream) - Constructor for class grph.io.DynamicsLogger
 
DynamicsModel<G extends Grph> - Class in grph.dynamics
 
DynamicsModel(DES<G>) - Constructor for class grph.dynamics.DynamicsModel
 

E

e2i(E) - Method in class grph.oo.ObjectGrph
 
e2i(Set<E>) - Method in class grph.oo.ObjectGrph
 
EdgeLabelBasedSubgraphMatcher - Class in grph.algo.subgraph_isomorphism.own
 
EdgeLabelBasedSubgraphMatcher() - Constructor for class grph.algo.subgraph_isomorphism.own.EdgeLabelBasedSubgraphMatcher
 
EdgeListReader - Class in grph.io
Enables reading graph data in which each line represents an edges.
EdgeListReader() - Constructor for class grph.io.EdgeListReader
 
EdgeListWriter - Class in grph.io
 
EdgeListWriter() - Constructor for class grph.io.EdgeListWriter
 
EdgeProperty - Class in grph.algo.msp
 
EdgeProperty(int, int) - Constructor for class grph.algo.msp.EdgeProperty
 
EdgeRemovalMutation - Class in grph.topology.random.genetic
 
EdgeRemovalMutation() - Constructor for class grph.topology.random.genetic.EdgeRemovalMutation
 
edges - Variable in class grph.algo.structural.MultigraphnessResult
 
EdgeSet - Interface in grph
 
edit(Grph) - Method in interface grph.edit.GrphEditor
 
ElementFilter - Class in grph
A filter for selecting (or not) vertices or edges.
ElementFilter() - Constructor for class grph.ElementFilter
 
ElementFilter.DegreeFilter - Class in grph
 
ElementFilter.LeafFilter - Class in grph
 
ElementFilter.LoopFilter - Class in grph
 
ElementFilter.SimplicialVertexFilter - Class in grph
 
enabled - Static variable in class grph.GrphWebNotifications
 
ensureCompiled(Logger) - Method in class grph.algo.AntCliqueAlgorithm
 
ensureCompiled() - Static method in class grph.algo.DreadnautAlgorithm
 
ensureCompiled(Logger) - Method in class grph.algo.lad.LAD
 
ensureCompiled() - Static method in class grph.algo.ogdf.OGDFAlgorithm
 
ensureCompiled(Logger) - Static method in class grph.algo.partitionning.metis.Gpmetis
 
ensureCompiled() - Static method in class grph.algo.structural.cliquer.Cliquer
 
ensureNVertices(int) - Method in class grph.Grph
Ensure this graph has at least the specified amount of vertices.
equals(Object) - Method in class grph.Grph
Checks if this graph contains the given graph.
equals(Grph) - Method in class grph.Grph
Checks if this graph equals the given graph.
equals(Object) - Method in class grph.path.AbstractPath
 
equals(Path) - Method in class grph.path.AbstractPath
 
equals(Object) - Method in class grph.path.ArrayListPath
 
equals(ArrayListPath) - Method in class grph.path.ArrayListPath
 
equals(Object) - Method in class grph.path.PathExtender
 
equals(Object) - Method in class grph.util.Matching
 
equals(Matching) - Method in class grph.util.Matching
 
ErdosRenyiRandomizedScheme - Class in grph.algo.topology
 
ErdosRenyiRandomizedScheme() - Constructor for class grph.algo.topology.ErdosRenyiRandomizedScheme
 
executable - Static variable in class grph.algo.triangles.latapi.MatthieuLatapyTriangleAlgorithm
 
execute() - Method in class grph.dynamics.DynamicsEvent
 
execute(String) - Method in class grph.edit.ShellEditor
 
extend(int) - Method in class grph.path.AbstractPath
 
extend(int, int) - Method in class grph.path.ArrayListPath
 
extend(int, int) - Method in class grph.path.ArrayPath
 
extend(int) - Method in interface grph.path.Path
 
extend(int, int) - Method in interface grph.path.Path
 
extend(int, int) - Method in class grph.path.PathExtender
 
extend(int, int) - Method in class grph.path.SearchResultWrappedPath
 
extend(int, int) - Method in class grph.path.SingletonPath
 
extension_readerClass - Static variable in class grph.io.AbstractGraphReader
 
extension_writer - Static variable in class grph.io.AbstractGraphWriter
 

F

farestVertex() - Method in class grph.algo.search.SearchResult
 
farther(Grph, IntSet) - Static method in class grph.algo.topology.gsm.WirelessBackhaul
 
FileWrite - Class in grph.demo
 
FileWrite() - Constructor for class grph.demo.FileWrite
 
find(int, Grph, int) - Static method in class grph.algo.HamiltonianPaths
 
findAlgorithm(String) - Method in class grph.Grph
 
FindAllCliques - Class in grph.algo.structural.cliquer
 
FindAllCliques() - Constructor for class grph.algo.structural.cliquer.FindAllCliques
 
FindAllCycles - Class in grph.algo
 
FindAllCycles(Grph) - Constructor for class grph.algo.FindAllCycles
 
FindAllCycles(Grph, IntSet, boolean) - Constructor for class grph.algo.FindAllCycles
 
FindAllCycles - Class in grph.algo.subgraph_isomorphism.own
 
FindAllCycles() - Constructor for class grph.algo.subgraph_isomorphism.own.FindAllCycles
 
findAllMatches(Grph, Grph) - Method in class grph.algo.subgraph_isomorphism.GraphMatchingAlgorithm
 
findAllMatches(Grph, Collection<String>, Property, Property) - Method in class grph.algo.subgraph_isomorphism.own.LabelBasedSubgraphMatcher
 
findAllMatches(Grph, Grph) - Method in class grph.algo.subgraph_isomorphism.own.SubgraphSearch
 
findAllPathsMatching(Grph, Collection<String>, Property, Property) - Method in class grph.algo.subgraph_isomorphism.own.LabelBasedSubgraphMatcher
 
FindAllTrianglesAlgorithm - Class in grph.algo
 
FindAllTrianglesAlgorithm() - Constructor for class grph.algo.FindAllTrianglesAlgorithm
 
findBooleanProperties() - Method in class grph.report.Report
 
findDistributionProperties() - Method in class grph.report.Report
 
findElementsWithValue(long, IntSet) - Method in class grph.properties.NumericalProperty
 
findLongestPath(Collection<Path>) - Static method in class grph.Paths
 
findMatchingPaths(Set<String>) - Method in class grph.oo.ObjectGrph
 
findMatrixProperties() - Method in class grph.report.Report
 
findOneMatch(Grph, Grph) - Method in class grph.algo.subgraph_isomorphism.GraphMatchingAlgorithm
 
findPathHeadingFrom(int, Collection<Path>) - Static method in class grph.Paths
 
findPathsConnecting(int, int, Collection<Path>) - Static method in class grph.Paths
 
findPathsHeadingTo(int, Collection<Path>) - Static method in class grph.Paths
 
findPathsMatching(Collection<Path>, String, Property, Property) - Method in class grph.algo.subgraph_isomorphism.own.LabelBasedSubgraphMatcher
 
findPathsPassingBy(int, Collection<Path>) - Static method in class grph.Paths
 
findProperty(String, Set<Property>) - Static method in class grph.properties.Property
Finds a given property by its name.
findPropertyByName(String) - Method in class grph.Grph
 
findReader(String) - Static method in class grph.io.AbstractGraphReader
 
findScalarProperties() - Method in class grph.report.Report
 
findWriter(String) - Static method in class grph.io.AbstractGraphWriter
 
first - Variable in class grph.VertexPair
 
flatten(Int2ObjectMap<List<Collection<Path>>>) - Static method in class grph.algo.AllPaths
 
FloydWarshallAlgorithm - Class in grph.algo.distance
 
FloydWarshallAlgorithm(NumericalProperty) - Constructor for class grph.algo.distance.FloydWarshallAlgorithm
 
FominGrandoniKratschMaximumindependentSetAlgorithm - Class in grph.algo.covering_packing
This class provides an implementation of the algorithm proposed by Fomin, Grandoni and Kratsch for computing a maximum independent set, based on foldable vertices and mirroring, in F.V.
FominGrandoniKratschMaximumindependentSetAlgorithm() - Constructor for class grph.algo.covering_packing.FominGrandoniKratschMaximumindependentSetAlgorithm
 
FominGrandoniKratschMaximumindependentSetAlgorithm - Variable in class grph.Grph
 
FourSweepIterativeFringeDiameterAlgorithm - Class in grph.algo.distance
Computes the diameter of the graph using the heuristic algorithm proposed by Pierluigi Crescenzi, Roberto Grossi, Michel Habib, Leonardo Lanzi and Andrea Marino in “On computing the diameter of real-world undirected graphs”.
FourSweepIterativeFringeDiameterAlgorithm() - Constructor for class grph.algo.distance.FourSweepIterativeFringeDiameterAlgorithm
 
fromCaidaMap(RegularFile) - Static method in class grph.Grph
Builds a new graph from the given CAIDA map.
fromGraphML(String) - Static method in class grph.Grph
 
fromGraphML(String, Class, Class) - Static method in class grph.Grph
 
fromGrphBinary(byte[]) - Static method in class grph.Grph
 
fromGrphText(String) - Static method in class grph.Grph
 
fromGrphTextFile(String) - Static method in class grph.Grph
 

G

GenerateGLP - Class in grph.demo
 
GenerateGLP() - Constructor for class grph.demo.GenerateGLP
 
GenerateGrid - Class in grph.demo
 
GenerateGrid() - Constructor for class grph.demo.GenerateGrid
 
get(int, int) - Method in class grph.algo.AdjacencyMatrix
 
get(Object, Object...) - Method in class grph.Cache
 
getA() - Method in class grph.algo.topology.rmat.RmatTopologyGenerator
 
getAccessMode() - Method in class grph.algo.search.BFSAlgorithm
 
getAccessMode() - Method in class grph.algo.search.DFSAlgorithm
 
getAccessMode() - Method in class grph.algo.search.TreeBasedTraversal
 
getAdjacencyMatrix() - Method in class grph.Grph
Computes a adjacency matrix for this graph.
getAlgo() - Method in class grph.algo.topology.BriteTopologyGenerator
 
getAlgorithm() - Method in class grph.algo.triangles.latapi.MatthieuLatapyTriangleAlgorithm
 
getAlgorithmName() - Method in class grph.algo.ogdf.OGDFAlgorithm
 
getAlgorithmName() - Method in class grph.algo.ogdf.OGDFDiameterAlgorithm
 
getAlgorithmName() - Method in class grph.algo.ogdf.OGDFPlanarityAlgorithm
 
getAllCycles() - Method in class grph.Grph
 
getAllCycles() - Method in class grph.oo.ObjectGrph
 
getAllInEdgeDegrees() - Method in class grph.Grph
 
getAllOutEdgeDegrees() - Method in class grph.Grph
 
getAllPaths() - Method in class grph.Grph
 
getAllPaths() - Method in class grph.oo.ObjectGrph
 
getAppletInfo() - Method in class GrphApplet
 
getApplicationName() - Method in class grph.script.AbstractGrphScript
 
getAssigments() - Method in class grph.algo.MaxFlowAlgorithmResult
 
getAuthor() - Method in class grph.script.AbstractGrphScript
 
getAverageClusteringCoefficient() - Method in class grph.Grph
Computes the average clustering coefficient of this graph.
getAverageDegree() - Method in class grph.Grph
Computes the average degree of this graph.
getAverageDegree(Grph.TYPE, Grph.DIRECTION) - Method in class grph.Grph
Computes the average degree of this graph.
getAvgTimeRequiredForComputing() - Method in class grph.GrphAlgorithmCache
 
getAWTColor(int) - Method in class grph.properties.ColorProperty
 
getB() - Method in class grph.algo.topology.rmat.RmatTopologyGenerator
 
getBeta() - Method in class grph.algo.topology.GLPIssamTopologyGenerator
 
getBipartiteSubgraphInducedByVertices(IntSet, IntSet) - Method in class grph.Grph
 
getBrite(int, BriteTopologyGenerator.ALGO, BriteTopologyGenerator.NODE_PLACEMENT, BriteTopologyGenerator.GrowthType, BriteTopologyGenerator.BWDist, int, int, int, double, double, double, double) - Static method in class grph.algo.topology.BriteTopologyGenerator
 
getBrite(int, BriteTopologyGenerator.ALGO, BriteTopologyGenerator.NODE_PLACEMENT, BriteTopologyGenerator.GrowthType, BriteTopologyGenerator.BWDist, int, int, int, double, double, double, double, long) - Static method in class grph.algo.topology.BriteTopologyGenerator
 
getBwDist() - Method in class grph.algo.topology.BriteTopologyGenerator
 
getbWMax() - Method in class grph.algo.topology.BriteTopologyGenerator
 
getbWMin() - Method in class grph.algo.topology.BriteTopologyGenerator
 
getC() - Method in class grph.algo.topology.rmat.RmatTopologyGenerator
 
getCachedAlgorithm() - Method in class grph.GrphAlgorithmCache
Returns the underlying algorithm.
getCachedValue() - Method in class grph.GrphAlgorithmCache
 
getCenter() - Method in class grph.algo.topology.StarTopologyGenerator
 
getCenter() - Method in class grph.Grph
Retrieves the vertex at the center of the graph.
getCircleStar() - Method in class grph.Grph
 
getCliques() - Method in class grph.Grph
 
getClusterHeads() - Method in class grph.algo.clustering.Clustering
 
getClusteringCoefficient(int) - Method in class grph.Grph
 
getClusteringCoefficient() - Method in class grph.Grph
 
getClusteringCoefficientDistribution(Grph) - Static method in class grph.algo.clustering.ClusteringCoefficient
Computes a clustering coefficient distribution for this graph
getClusteringCoefficientDistribution() - Method in class grph.Grph
 
getClusters() - Method in class grph.algo.clustering.Clustering
 
getColor(int) - Method in class ColorMap
 
getColor() - Method in interface grph.oo.Grphable
 
getColorClass(int) - Method in class grph.algo.coloring.GraphColoring
Returns the color class indexed by the specified nonnegative integer.
getColorMap() - Method in class grph.properties.ColorProperty
 
getComment() - Method in class grph.report.Metric
 
getComplement() - Method in class grph.Grph
Computes the complement graph for this graph.
getComponent() - Method in class grph.gui.GraphRenderer
 
getComponent() - Method in class grph.gui.GraphVizPNGGrphRenderer
 
getConnectedComponentContaining(int, Grph.DIRECTION) - Method in class grph.Grph
Computes the connected component containing the given vertex, according to the given search direction.
getConnectedComponents() - Method in class grph.Grph
Computes the set of connected component on this graph.
getCutEdges(IntSet, IntSet) - Method in class grph.Grph
Computes the edges describing the cut formed by the two given sets.
getCutSize(IntSet, IntSet) - Method in class grph.Grph
Compute the size of the cut.
getDefaultEdgeColor() - Method in class ColorMap
 
getDefaultNumberOfThreads() - Static method in class grph.Grph
 
getDefaultVertexColor() - Method in class ColorMap
 
getDegreeDistribution(Grph.TYPE, Grph.DIRECTION) - Method in class grph.Grph
Computes a degree distribution for this graph
getDensity() - Method in class grph.Grph
Computes the exact density of this graph.
getDes() - Method in class grph.dynamics.DynamicsModel
 
getDescription() - Method in class grph.Grph
Computes a textual description for this graph.
getDestination() - Method in class grph.path.ArrayListPath
 
getDestination() - Method in class grph.path.ArrayPath
 
getDestination() - Method in interface grph.path.Path
The last vertex in the path
getDestination() - Method in class grph.path.PathExtender
 
getDestination() - Method in class grph.path.SearchResultWrappedPath
 
getDestination() - Method in class grph.path.SingletonPath
 
getDiameter() - Method in class grph.Grph
Computes the exact diameter of this graph.
getDifference(Grph) - Method in class grph.Grph
Compares this graph and the given graph and returns the first difference found.
getDirectedHyperEdgeHead(int) - Method in interface grph.DirectedHyperGraph
 
getDirectedHyperEdgeHead(int) - Method in class grph.in_memory.InMemoryGrph
Assuming the given edge is a directed hyper edge, retrieves its head.
getDirectedHyperEdgeTail(int) - Method in interface grph.DirectedHyperGraph
 
getDirectedHyperEdgeTail(int) - Method in class grph.in_memory.InMemoryGrph
Assuming the given edge is a directed hyper edge, retrieves its tail.
getDirectedSimpleEdgeHead(int) - Method in interface grph.DirectedSimpleGraph
 
getDirectedSimpleEdgeHead(int) - Method in class grph.in_memory.InMemoryGrph
Assuming the given edge is a directed simple edge, retrieves its head.
getDirectedSimpleEdgeHead(E) - Method in class grph.oo.ObjectGrph
 
getDirectedSimpleEdgeTail(int) - Method in interface grph.DirectedSimpleGraph
 
getDirectedSimpleEdgeTail(int) - Method in class grph.in_memory.InMemoryGrph
Assuming the given edge is a directed simple edge, retrieves its tail.
getDirectedSimpleEdgeTail(E) - Method in class grph.oo.ObjectGrph
 
getDirection() - Method in class grph.algo.degree.AbstractDegreeAlgorithm
 
getDirection() - Method in class grph.algo.degree.MaxInEdgeDegreeAlgorithm
 
getDirection() - Method in class grph.algo.degree.MaxInVertexDegreeAlgorithm
 
getDirection() - Method in class grph.algo.degree.MaxOutEdgeDegreeAlgorithm
 
getDirection() - Method in class grph.algo.degree.MaxOutVertexDegreeAlgorithm
 
getDirection() - Method in class grph.algo.degree.MinInEdgeDegreeAlgorithm
 
getDirection() - Method in class grph.algo.degree.MinInVertexDegreeAlgorithm
 
getDirection() - Method in class grph.algo.degree.MinOutEdgeDegreeAlgorithm
 
getDirection() - Method in class grph.algo.degree.MinOutVertexDegreeAlgorithm
 
getDirection() - Method in class grph.algo.VertexAdjacencyAlgorithm
 
getDirection() - Method in class grph.algo.VertexAdjacencyAlgorithm.In
 
getDirection() - Method in class grph.algo.VertexAdjacencyAlgorithm.InOut
 
getDirection() - Method in class grph.algo.VertexAdjacencyAlgorithm.Out
 
getDistance(int, int) - Method in class grph.algo.distance.DistanceMatrix
 
getDistanceMatrix(NumericalProperty) - Method in class grph.Grph
Computes a distance matrix for this graph.
getDistribution() - Method in class grph.algo.distance.DistanceMatrix
 
getDistribution() - Method in class grph.algo.distance.PageRank
Computes the distribution for this page rank.
getE() - Method in class grph.algo.topology.rmat.RmatTopologyGenerator
 
getEccentricity(int, NumericalProperty) - Method in class grph.Grph
Computes the eccentricity of the given vertex.
getEccentricity(int) - Method in class grph.Grph
 
getEdgeColorProperty() - Method in class grph.Grph
 
getEdgeDegree(int) - Method in class grph.Grph
 
getEdgeHeadingToVertexAt(int) - Method in class grph.path.ArrayListPath
 
getEdgeHeadingToVertexAt(int) - Method in class grph.path.ArrayPath
 
getEdgeHeadingToVertexAt(int) - Method in interface grph.path.Path
 
getEdgeHeadingToVertexAt(int) - Method in class grph.path.PathExtender
 
getEdgeHeadingToVertexAt(int) - Method in class grph.path.SearchResultWrappedPath
 
getEdgeHeadingToVertexAt(int) - Method in class grph.path.SingletonPath
 
getEdgeLabel(int) - Method in class grph.algo.labelling.ContiguousLabelling
 
getEdgeLabel(int) - Method in class grph.algo.labelling.Incrementlabelling
 
getEdgeLabel(int) - Method in class grph.algo.labelling.Relabelling
 
getEdgeLabel(E) - Method in class grph.oo.ObjectGrph
 
getEdgeLabelProperty() - Method in class grph.Grph
 
getEdgeNature(int) - Method in class grph.Grph
Gets the nature of the given edge (undirected simple edge, directed simple edge, undirected hyper-edge or directed-hyperedge).
getEdgePairs() - Method in class grph.Grph
 
getEdgeProbability() - Method in class grph.algo.topology.RandomizedGridTopology
 
getEdges() - Method in interface grph.EdgeSet
 
getEdges() - Method in class grph.in_memory.InMemoryGrph
Retrieve the set of edges in this graph.
getEdges(V, V) - Method in class grph.oo.ObjectGrph
 
getEdges() - Method in class grph.oo.ObjectGrph
 
getEdges() - Method in class grph.oo.ObjectPath
 
getEdgesAdjacentToEdge(int) - Method in class grph.Grph
Computes the set of edges incident to vertices incident to the given edge.
getEdgesConnecting(int, int) - Method in class grph.Grph
 
getEdgesIncidentTo(int) - Method in class grph.Grph
Computes the set of edges incident to the given vertex.
getEdgeStyleProperty() - Method in class grph.Grph
 
getEdgeWeights() - Method in class grph.algo.distance.WeightedDistanceMatrixAlgorithm
 
getEdgeWidthProperty() - Method in class grph.Grph
 
getExtensions() - Static method in class grph.io.AbstractGraphWriter
 
getFartestVertex(int) - Method in class grph.Grph
 
getFartestVertex(int, NumericalProperty) - Method in class grph.Grph
 
getFiles() - Method in class grph.report.LatexDocument
 
getFlow() - Method in class grph.algo.MaxFlowAlgorithmResult
 
getFractionOfDegreeOneNodes() - Method in class grph.algo.topology.InetTopologyGenerator
 
getFringes(int, int) - Method in class grph.Grph
 
getG() - Method in class grph.gui.GraphRenderer
 
getGirth() - Method in class grph.Grph
The girth of a graph is defined as the length of a shortest cycle, or infinite if the graph is acyclic.
getGpmetisPartitionning(int, Random) - Method in class grph.Grph
 
getGpmetisPartitionning(int, Gpmetis.Ptype, Gpmetis.Ctype, Gpmetis.Iptype, Gpmetis.Objtype, boolean, boolean, int, int, int, Random) - Method in class grph.Grph
 
getGraphstreamEdge(int) - Method in class grph.gui.GraphstreamBasedRenderer
 
getGraphstreamGraph() - Method in class grph.gui.GraphstreamBasedRenderer
 
getGraphstreamNode(int) - Method in class grph.gui.GraphstreamBasedRenderer
 
getGreatest() - Method in interface grph.GrphIntSet
 
getGrowthType() - Method in class grph.algo.topology.BriteTopologyGenerator
 
getGrph() - Method in class grph.dynamics.DynamicsModel
 
getGrph() - Method in class grph.report.Report
 
getGrphID() - Method in interface grph.oo.Grphable
 
getHead() - Method in class grph.algo.clustering.Cluster
 
getHeight() - Method in class grph.algo.topology.GridTopologyGenerator
 
getHeight() - Method in class grph.algo.topology.RandomizedGridTopology
 
getId() - Method in class grph.algo.msp.EdgeProperty
 
getID() - Method in class grph.in_memory.InMemoryGrph
 
getInaccessibleVertices() - Method in class grph.Grph
Returns a set of vertices that are inaccessible (e.g.
getIncidenceMatrix() - Method in class grph.Grph
Computes a incidence matrix for this graph.
getIncidentEdges(V) - Method in class grph.oo.ObjectGrph
 
getIncidentVertices(E) - Method in class grph.oo.ObjectGrph
 
getInducedSubgraphIsomorphism(Grph, boolean) - Method in class grph.Grph
Returns if the given "pattern graph" is isomorphic to a subgraph in this graph.
getInEdgeDegree(int) - Method in class grph.Grph
 
getInEdges(int) - Method in class grph.Grph
Computes the set of out-edges for the given vertex.
getInElements(int) - Method in class grph.Grph
 
getInNeighborhoods() - Method in class grph.Grph
 
getInNeighbors(int) - Method in class grph.Grph
 
getInNeighbours(int) - Method in class grph.Grph
 
getInOnlyEdges(int) - Method in class grph.Grph
 
getInOnlyElements(int) - Method in interface grph.DirectedGraph
 
getInOnlyElements(int) - Method in class grph.in_memory.InMemoryGrph
 
getInOutOnlyEdges(int) - Method in class grph.Grph
 
getInOutOnlyElements(int) - Method in interface grph.DirectedGraph
 
getInOutOnlyElements(int) - Method in class grph.in_memory.InMemoryGrph
 
getInVertexDegree(int) - Method in class grph.Grph
 
getIsolatedVertices() - Method in class grph.Grph
Computes the set of isolated vertices in this graph.
getK() - Method in class grph.algo.topology.KClosestNeighborsTopologyGenerator
 
getK() - Method in class grph.algo.topology.RandomNewmanWattsStrogatzTopologyGenerator
 
getKClosestNeighbors(int, int, NumericalProperty) - Method in class grph.Grph
 
getKShortestPaths(int, int, int, NumericalProperty) - Method in class grph.Grph
 
getLabel() - Method in interface grph.oo.Grphable
 
getLargestCluster() - Method in class grph.algo.clustering.Clustering
 
getLargestConnectedComponent() - Method in class grph.Grph
Determines the largest connected component in the graph.
getLatex() - Method in class grph.report.LatexDocument
 
getLength() - Method in class grph.oo.ObjectPath
 
getLength() - Method in class grph.path.AbstractPath
 
getLength() - Method in interface grph.path.Path
Computes the length of this path.
getLicence() - Method in class grph.script.AbstractGrphScript
 
getLineGraph() - Method in class grph.Grph
Computes the line graph of this graph.
getLineGraph(int) - Method in class grph.Grph
Computes n iterations of the "line graph" operation on this graph.
getListeners() - Method in class grph.dynamics.DynamicsModel
 
getListeners() - Method in class grph.properties.Property
 
getLocalClusteringCoefficient(Grph, int) - Static method in class grph.algo.clustering.ClusteringCoefficient
Computes the local clustering coefficient of the given vertex v, defined as the number of edges in G[N(v)] over the maximum possible number of edges in G[N(v)] if it was a clique.
getLocalClusteringCoefficients() - Method in class grph.Grph
 
getLocation() - Method in class grph.report.LatexDocument
 
getLongestPathLength() - Method in class grph.algo.distance.DistanceMatrix
 
getLoops(int) - Method in class grph.Grph
Computes the set of self-loops incident to the given vertex
getLowestIDAvailable() - Method in class grph.in_memory.GrphIntSet
 
getLP(Grph) - Method in class grph.algo.LPBasedAlgorithm
 
getLP(Grph) - Method in class grph.algo.StructuredLPBasedAlgorithm
 
getMatching(Grph, Grph) - Static method in class grph.algo.DreadnautAlgorithm
 
getMatching(Grph, Grph, boolean) - Static method in class grph.algo.DreadnautAlgorithm
 
getMatrixIndexFromVertex(int) - Method in class grph.algo.AdjacencyMatrix
 
getMaxDegree(Grph, Grph.TYPE, Grph.DIRECTION) - Static method in class grph.algo.degree.AbstractDegreeAlgorithm
 
getMaximumClique() - Method in class grph.Grph
Computes the maximum clique in this graph, using an ant-based algorithm defined by Chistine Solnon.
getMaximumIndependentSet() - Method in class grph.Grph
Computes a independent set of maximum cardinality, based on
getMaximumIndependentSet(Grph.MaxIndependentSetAlgorithm) - Method in class grph.Grph
 
getMaximumMatching() - Method in class grph.Grph
Computes a maximum (cardinality) matching.
getMaxInEdgeDegrees() - Method in class grph.Grph
 
getMaxInVertexDegrees() - Method in class grph.Grph
 
getMaxOutEdgeDegrees() - Method in class grph.Grph
 
getMaxOutVertexDegrees() - Method in class grph.Grph
 
getMemoryFootprintInBytes() - Method in class grph.properties.NumericalProperty
 
getMemoryFootprintInBytes() - Method in class grph.properties.ObjectProperty
 
getMinDegree(Grph, Grph.TYPE, Grph.DIRECTION) - Static method in class grph.algo.degree.AbstractDegreeAlgorithm
 
getMinimumVertexCover() - Method in class grph.Grph
Computes a vertex cover of minimum cardinality.
getMinimumVertexCover(Grph.MinVertexCoverAlgorithm) - Method in class grph.Grph
Computes a minimum vertex cover by applying the specified algorithm.
getMinInEdgeDegrees() - Method in class grph.Grph
 
getMinInVertexDegrees() - Method in class grph.Grph
 
getMinOutEdgeDegrees() - Method in class grph.Grph
 
getMinOutVertexDegrees() - Method in class grph.Grph
 
getName() - Method in class grph.algo.lad.DirectedLAD
 
getName() - Method in class grph.algo.lad.LAD
 
getName() - Method in class grph.algo.lad.UndirectedLAD
 
getName() - Method in class grph.properties.Property
 
getName() - Method in class grph.report.Metric
 
getNavigation() - Method in interface grph.DirectedGraph
 
getNavigation() - Method in class grph.in_memory.InMemoryGrph
 
getNEdgesPerStep() - Method in class grph.algo.topology.GLPIssamTopologyGenerator
 
getNeighborhoods() - Method in class grph.Grph
 
getNeighbors(Grph.DIRECTION) - Method in class grph.Grph
 
getNeighborsAtMaxDistance(int, int, NumericalProperty) - Method in class grph.Grph
 
getNeighbours(int) - Method in class grph.Grph
Computes the set of neighbors of the given vertex, cumulating in and out neighbors.
getNeighbours(IntSet) - Method in class grph.Grph
Computes the (open) neighborhood of the set s of vertices (that is the set of vertices that have at least one neighbour in s, and do not belong to s)
getNeighbours(int, Grph.DIRECTION) - Method in class grph.Grph
 
getNeighboursAtMostKHops(int, int) - Method in class grph.Grph
 
getNextEdgeAvailable() - Method in interface grph.EdgeSet
 
getNextEdgeAvailable() - Method in class grph.in_memory.InMemoryGrph
 
getNextVertexAvailable() - Method in class grph.in_memory.InMemoryGrph
 
getNextVertexAvailable() - Method in interface grph.VertexSet
 
getNInitialNodes() - Method in class grph.algo.topology.GLPIssamTopologyGenerator
 
getNodePlacement() - Method in class grph.algo.topology.BriteTopologyGenerator
 
getNumberOfDirectedEdges() - Method in class grph.Grph
 
getNumberOfDirectedHyperEdges() - Method in interface grph.DirectedHyperGraph
 
getNumberOfDirectedHyperEdges() - Method in class grph.in_memory.InMemoryGrph
 
getNumberOfDirectedSimpleEdges() - Method in interface grph.DirectedSimpleGraph
 
getNumberOfDirectedSimpleEdges() - Method in class grph.in_memory.InMemoryGrph
 
getNumberOfEdges() - Method in class grph.algo.topology.GNMTopologyGenerator
 
getNumberOfEdges() - Method in class grph.Grph
 
getNumberOfHyperEdges() - Method in class grph.Grph
 
getNumberOfNeighboringNodesEachNewNodeConnects() - Method in class grph.algo.topology.BriteTopologyGenerator
 
getNumberOfOccurences(int) - Method in class grph.algo.distance.PageRank
Retrieves the number of times the given vertex was encountered along the random walks
getNumberOfSimpleEdges() - Method in class grph.Grph
 
getNumberOfSquaresInInnerPlanes() - Method in class grph.algo.topology.BriteTopologyGenerator
 
getNumberOfSquaresInTheMainPlane() - Method in class grph.algo.topology.BriteTopologyGenerator
 
getNumberOfStepsInAJump() - Method in class grph.stepper.AbstractStepper
 
getNumberOfStepsUntilNextWait() - Method in class grph.stepper.AbstractStepper
 
getNumberOfTimesAComputationWasPerformed() - Method in class grph.GrphAlgorithmCache
 
getNumberOfTimesTheCacheWasUsed() - Method in class grph.GrphAlgorithmCache
 
getNumberOfTriangles() - Method in class grph.Grph
Computes the number of triangles in the graph.
getNumberOfUndirectedEdges() - Method in class grph.Grph
 
getNumberOfUndirectedHyperEdges() - Method in class grph.in_memory.InMemoryGrph
 
getNumberOfUndirectedHyperEdges() - Method in interface grph.UndirectedHyperGraph
 
getNumberOfUndirectedSimpleEdges() - Method in class grph.in_memory.InMemoryGrph
 
getNumberOfUndirectedSimpleEdges() - Method in interface grph.UndirectedSimpleGraph
 
getNumberOfVertices() - Method in class grph.Grph
Computes the number of vertices in this graph.
getNumberOfVertices() - Method in class grph.path.ArrayListPath
 
getNumberOfVertices() - Method in class grph.path.ArrayPath
 
getNumberOfVertices() - Method in interface grph.path.Path
 
getNumberOfVertices() - Method in class grph.path.PathExtender
 
getNumberOfVertices() - Method in class grph.path.SearchResultWrappedPath
 
getNumberOfVertices() - Method in class grph.path.SingletonPath
 
getOneVertex(int) - Method in class grph.in_memory.InMemoryGrph
Assuming the given edge is an undirected simple edge, retrieves one of its incident vertices.
getOneVertex(int) - Method in interface grph.UndirectedSimpleGraph
 
getOperator() - Method in class grph.algo.covering_packing.LPBasedMaximumIndependentSetAlgorithm
 
getOperator() - Method in class grph.algo.covering_packing.LPBasedMinimumVertexCoverAlgorithm
 
getOppositeEdges(int) - Method in class grph.Grph
 
getOptimizationType() - Method in class grph.algo.covering_packing.LPBasedMaximumIndependentSetAlgorithm
 
getOptimizationType() - Method in class grph.algo.covering_packing.LPBasedMaximumMatchingAlgorithm
 
getOptimizationType() - Method in class grph.algo.covering_packing.LPBasedMinimumVertexCoverAlgorithm
 
getOptimizationType() - Method in class grph.algo.StructuredLPBasedAlgorithm
 
getOrder() - Method in class grph.Grph
Computes the order of this graph.
getOut() - Method in class grph.io.DynamicsLogger
 
getOutEdgeDegree(int) - Method in class grph.Grph
 
getOutEdges(int) - Method in class grph.Grph
Computes the set of out-edges for the given vertex.
getOutNeighborhoods() - Method in class grph.Grph
Computes the vertex adjacency of the graph in the form of a two-dimension int array.
getOutNeighbors(int) - Method in class grph.Grph
Computes the set of out-neighbors of the given vertex.
getOutNeighbors(V) - Method in class grph.oo.ObjectGrph
 
getOutOnlyEdges(int) - Method in class grph.Grph
 
getOutOnlyElements(int) - Method in interface grph.DirectedGraph
 
getOutOnlyElements(int) - Method in class grph.in_memory.InMemoryGrph
 
getOutVertexDegree(int) - Method in class grph.Grph
 
getP() - Method in class grph.algo.topology.GLPIssamTopologyGenerator
 
getP() - Method in class grph.algo.topology.RandomNewmanWattsStrogatzTopologyGenerator
 
getPageRanking(Random) - Method in class grph.Grph
 
getPalette() - Method in class grph.properties.NumericalProperty
 
getPartialSubgraphIsomorphism(Grph, boolean) - Method in class grph.Grph
Returns if the given "pattern graph" is partially isomorphic to a subgraph in this graph.
getPlaneDimension() - Method in class grph.algo.topology.InetTopologyGenerator
 
getPredecessor(int, int) - Method in class grph.algo.distance.PredecessorMatrix
 
getPRNG() - Method in class grph.algo.topology.GLPIssamTopologyGenerator
 
getPrng() - Method in class grph.algo.topology.PlanarGraphTopologyGenerator
 
getPRNG() - Method in class grph.algo.topology.RandomizedTopologyTransform
 
getPRNG() - Method in class grph.dynamics.DynamicsModel
 
getProbability_() - Method in class grph.algo.topology.GNPTopologyGenerator
 
getProperties() - Method in class grph.Grph
Computes the set of properties applicable to this graph.
getProperties() - Method in class grph.report.Report
 
getRadius() - Method in class grph.Grph
Computes the exact radius of this graph.
getRandom() - Method in class grph.algo.k_shortest_paths.RandomWalkBasedKShortestPaths
 
getRank(int) - Method in class grph.algo.distance.PageRank
Computes the rank for the given vertex.
getS() - Method in class grph.algo.topology.rmat.RmatTopologyGenerator
 
getS2() - Method in class grph.algo.topology.rmat.RmatTopologyGenerator
 
getShortDescription() - Method in class grph.script.add_to_algorithm_repository
 
getShortDescription() - Method in class grph.script.biggest_graph_possible
 
getShortDescription() - Method in class grph.script.console
 
getShortDescription() - Method in class grph.script.convert
 
getShortDescription() - Method in class grph.script.demo_lifegame
 
getShortDescription() - Method in class grph.script.has_cycles
 
getShortDescription() - Method in class grph.script.heavy_grph_process
 
getShortDescription() - Method in class grph.script.illustrate_topologies
 
getShortDescription() - Method in class grph.script.render_graphstream
 
getShortDescription() - Method in class grph.script.render_shortest_path
 
getShortestCycle() - Method in class grph.Grph
 
getShortestPath(int, int, NumericalProperty) - Method in class grph.Grph
Computes a shortest path from the given source to the given destination.
getShortestPath(int, int) - Method in class grph.Grph
 
getSimplicialVertices() - Method in class grph.Grph
Comptes the set of simplitial vertices in this graph.
getSinks() - Method in class grph.Grph
Computes the set of sink vertices in this graph.
getSize() - Method in class grph.algo.AdjacencyMatrix
 
getSize() - Method in class grph.Grph
 
getSolver() - Method in class grph.algo.LPBasedAlgorithm
Gets the LP solver that will be used to compute the algorithm.
getSomeEdgeConnecting(int, int) - Method in class grph.Grph
Returns an (hyper)edge or arc that connects src and dest
getSource() - Method in class grph.path.ArrayListPath
 
getSource() - Method in class grph.path.ArrayPath
 
getSource() - Method in interface grph.path.Path
The first vertex in the path
getSource() - Method in class grph.path.PathExtender
 
getSource() - Method in class grph.path.SearchResultWrappedPath
 
getSource() - Method in class grph.path.SingletonPath
 
getSourceCode() - Method in class grph.GrphAlgorithm
 
getSourceCode() - Method in class grph.GrphAlgorithmCache
 
getSources() - Method in class grph.Grph
Computes the set of source vertices in this graph.
getSpanningTree() - Method in class grph.Grph
 
getStat() - Method in class grph.algo.degree.AbstractDegreeAlgorithm
 
getStat() - Method in class grph.algo.degree.MaxInEdgeDegreeAlgorithm
 
getStat() - Method in class grph.algo.degree.MaxInVertexDegreeAlgorithm
 
getStat() - Method in class grph.algo.degree.MaxOutEdgeDegreeAlgorithm
 
getStat() - Method in class grph.algo.degree.MaxOutVertexDegreeAlgorithm
 
getStat() - Method in class grph.algo.degree.MinInEdgeDegreeAlgorithm
 
getStat() - Method in class grph.algo.degree.MinInVertexDegreeAlgorithm
 
getStat() - Method in class grph.algo.degree.MinOutEdgeDegreeAlgorithm
 
getStat() - Method in class grph.algo.degree.MinOutVertexDegreeAlgorithm
 
getStronglyConnectedComponents() - Method in class grph.Grph
Tarjan's algorithm.
getSubGraph(Grph) - Method in class grph.oo.ObjectGrph
 
getSubgraphInducedByEdges(IntSet) - Method in class grph.Grph
Computes the subgraph induced by the given set of edges.
getSubgraphInducedByVertices(IntSet) - Method in class grph.Grph
Computes the subgraph induced by the given set of vertices.
getTheOtherVertex(int, int) - Method in class grph.in_memory.InMemoryGrph
Assuming the given edge is an undirected simple edge, retrieves the incident vertex other than thisVertex.
getTheOtherVertex(int, int) - Method in interface grph.UndirectedSimpleGraph
 
getTimeRequiredForComputingIfCacheWereNotUsed() - Method in class grph.GrphAlgorithmCache
 
getTimeSpentComputing() - Method in class grph.GrphAlgorithmCache
 
getTopologyListeners() - Method in class grph.Grph
Obtains the list of topology listeners for this graph.
getTotalNumberOfCallsFor() - Method in class grph.GrphAlgorithmCache
 
getTwoSweepBFSDiameterApproximatedDiameter() - Method in class grph.Grph
Computues a two-sweeps approximation of the diameter of this graph.
getType() - Method in class grph.algo.degree.AbstractDegreeAlgorithm
 
getType() - Method in class grph.algo.degree.MaxInEdgeDegreeAlgorithm
 
getType() - Method in class grph.algo.degree.MaxInVertexDegreeAlgorithm
 
getType() - Method in class grph.algo.degree.MaxOutEdgeDegreeAlgorithm
 
getType() - Method in class grph.algo.degree.MaxOutVertexDegreeAlgorithm
 
getType() - Method in class grph.algo.degree.MinInEdgeDegreeAlgorithm
 
getType() - Method in class grph.algo.degree.MinInVertexDegreeAlgorithm
 
getType() - Method in class grph.algo.degree.MinOutEdgeDegreeAlgorithm
 
getType() - Method in class grph.algo.degree.MinOutVertexDegreeAlgorithm
 
getUndirectedHyperEdgeVertices(int) - Method in class grph.in_memory.InMemoryGrph
Computes the set of vertices incident to the given hyper-edge.
getUndirectedHyperEdgeVertices(int) - Method in interface grph.UndirectedHyperGraph
 
getValue(Grph, int) - Method in class grph.algo.sort.OutDegreeSorter
 
getValue(Grph, int) - Method in class grph.algo.sort.Sorter
 
getValue(int) - Method in class grph.in_memory.IncidenceList
 
getValue(int) - Method in class grph.properties.NumericalProperty
 
getValue(int) - Method in class grph.properties.ObjectProperty
 
getValue() - Method in class grph.report.Metric
 
getValueAsColor(int) - Method in class grph.properties.NumericalProperty
 
getValueAsDouble(int) - Method in class grph.properties.NumericalProperty
 
getValueAsFloat(int) - Method in class grph.properties.NumericalProperty
 
getValueAsInt(int) - Method in class grph.properties.NumericalProperty
 
getValueAsString(int) - Method in class grph.properties.NumericalProperty
 
getValueAsString(int) - Method in class grph.properties.ObjectProperty
 
getValueAsString(int) - Method in class grph.properties.Property
 
getVariableType(Variable) - Method in class grph.algo.covering_packing.LPBasedMaximumMatchingAlgorithm
 
getVariableType(Variable) - Method in class grph.algo.StructuredLPBasedAlgorithm
 
getVersion() - Static method in class grph.Grph
Computes the version of the Grph library installed.
getVersion() - Method in class grph.script.AbstractGrphScript
 
getVertex() - Method in class grph.dynamics.DynamicsEvent
 
getVertexAt(int) - Method in class grph.path.ArrayListPath
 
getVertexAt(int) - Method in class grph.path.ArrayPath
 
getVertexAt(int) - Method in interface grph.path.Path
 
getVertexAt(int) - Method in class grph.path.PathExtender
 
getVertexAt(int) - Method in class grph.path.SearchResultWrappedPath
 
getVertexAt(int) - Method in class grph.path.SingletonPath
 
getVertexColorProperty() - Method in class grph.Grph
 
getVertexDegree(int, Grph.TYPE, Grph.DIRECTION) - Method in class grph.Grph
Computes different types of degrees of the given vertex.
getVertexDegree(int) - Method in class grph.Grph
 
getVertexFromMatrixIndex(int) - Method in class grph.algo.AdjacencyMatrix
 
getVertexLabel(int) - Method in class grph.algo.labelling.ContiguousLabelling
 
getVertexLabel(int) - Method in class grph.algo.labelling.Incrementlabelling
 
getVertexLabel(int) - Method in class grph.algo.labelling.Relabelling
 
getVertexLabel(V) - Method in class grph.oo.ObjectGrph
 
getVertexLabelProperty() - Method in class grph.Grph
 
getVertexSet() - Method in class grph.path.AbstractPath
Computes the vertices in this path as a set.
getVertexSet() - Method in interface grph.path.Path
Deprecated.
getVertexShapeProperty() - Method in class grph.Grph
 
getVertexSizeProperty() - Method in class grph.Grph
 
getVertices() - Method in class grph.in_memory.InMemoryGrph
Retrieve the set of vertices in this graph.
getVertices() - Method in class grph.oo.ObjectGrph
 
getVertices() - Method in class grph.oo.ObjectPath
 
getVertices() - Method in interface grph.VertexSet
 
getVerticesAccessibleThrough(int, int) - Method in class grph.Grph
 
getVerticesAccessibleThrough(int, IntSet) - Method in class grph.Grph
 
getVerticesIncidentToEdge(int) - Method in class grph.Grph
Computes the set of vertices incident to the given edge.
getVerticesOfDegree(int) - Method in class grph.Grph
Returns the subset of vertices that have a degree equal to degree.
getVerticesOfDegree(int, Grph.DIRECTION) - Method in class grph.Grph
Returns the subset of vertices that have a in-degree or out-degree equal to degree, depending on the dir parameter's value.
getVerticesOfDegreeAtLeast(int) - Method in class grph.Grph
Returns the subset of vertices that have a degree at least degree.
getWaxmanAlpha() - Method in class grph.algo.topology.BriteTopologyGenerator
 
getWaxmanBeta() - Method in class grph.algo.topology.BriteTopologyGenerator
 
getWeight() - Method in class grph.algo.msp.EdgeProperty
 
getWeightProperty() - Method in class grph.algo.search.WeightedSingleSourceSearchAlgorithm
 
getWidth() - Method in class grph.algo.topology.GridTopologyGenerator
 
getWidth() - Method in class grph.algo.topology.RandomizedGridTopology
 
getYear() - Method in class grph.script.AbstractGrphScript
 
GirthAlgorithm - Class in grph.algo.distance
 
GirthAlgorithm() - Constructor for class grph.algo.distance.GirthAlgorithm
 
girthAlgorithm - Variable in class grph.Grph
 
globalClusteringCoefficient - Variable in class grph.algo.triangles.latapi.Result
 
GlobalClusteringCoefficientAlgorithm - Class in grph.algo.clustering
 
GlobalClusteringCoefficientAlgorithm() - Constructor for class grph.algo.clustering.GlobalClusteringCoefficientAlgorithm
 
glp() - Method in class grph.Grph
Computes a GLP topology from the vertices in the graph.
GLPIssamTopologyGenerator - Class in grph.algo.topology
 
GLPIssamTopologyGenerator() - Constructor for class grph.algo.topology.GLPIssamTopologyGenerator
 
GMLWriter - Class in grph.io
http://www.fim.uni-passau.de/en/fim/faculty/chairs/theoretische-informatik/projects.html
GMLWriter() - Constructor for class grph.io.GMLWriter
 
GNMTopologyGenerator - Class in grph.algo.topology
Erdos and Renyi GNM model: adds n edges to the graph, connecting random pairs of vertices.
GNMTopologyGenerator() - Constructor for class grph.algo.topology.GNMTopologyGenerator
 
GNPTopologyGenerator - Class in grph.algo.topology
Erdos and Renyi GNP model: connect each pair of vertices according to a given probability.
GNPTopologyGenerator() - Constructor for class grph.algo.topology.GNPTopologyGenerator
 
Gpmetis - Class in grph.algo.partitionning.metis
 
Gpmetis() - Constructor for class grph.algo.partitionning.metis.Gpmetis
 
Gpmetis.Ctype - Enum in grph.algo.partitionning.metis
 
Gpmetis.Iptype - Enum in grph.algo.partitionning.metis
 
Gpmetis.Objtype - Enum in grph.algo.partitionning.metis
 
Gpmetis.Ptype - Enum in grph.algo.partitionning.metis
 
graph2pattern(int, int) - Method in class grph.util.Matching
 
graph2pattern() - Method in class grph.util.Matching
 
GraphBuildException - Exception in grph.io
 
GraphBuildException(String) - Constructor for exception grph.io.GraphBuildException
 
GraphColoring - Class in grph.algo.coloring
This class implements the notion of graph coloring.
GraphColoring() - Constructor for class grph.algo.coloring.GraphColoring
Constructs an empty coloring.
GraphColoring(int) - Constructor for class grph.algo.coloring.GraphColoring
Constructs an empty coloring with the specified number of empty color classes.
GraphCrossover - Class in grph.topology.random.genetic
It takes half of the vertices in g1 and the other half in g2.
GraphCrossover() - Constructor for class grph.topology.random.genetic.GraphCrossover
 
GraphMatchingAlgorithm - Class in grph.algo.subgraph_isomorphism
 
GraphMatchingAlgorithm() - Constructor for class grph.algo.subgraph_isomorphism.GraphMatchingAlgorithm
 
GraphMLReader - Class in grph.io.graphml
 
GraphMLReader() - Constructor for class grph.io.graphml.GraphMLReader
 
GraphMLWriter - Class in grph.io.graphml
http://graphml.graphdrawing.org/primer/graphml-primer.html#BCfile
GraphMLWriter() - Constructor for class grph.io.graphml.GraphMLWriter
 
GraphMLWriter.P - Class in grph.io.graphml
 
GraphPopulation - Class in grph.topology.random.genetic
 
GraphPopulation() - Constructor for class grph.topology.random.genetic.GraphPopulation
 
GraphRenderer - Class in grph.gui
 
GraphRenderer(Grph) - Constructor for class grph.gui.GraphRenderer
 
GraphSearchListener - Interface in grph.algo.search
 
GraphSearchListener.DECISION - Enum in grph.algo.search
 
GraphstreamBasedRenderer - Class in grph.gui
 
GraphstreamBasedRenderer(Grph) - Constructor for class grph.gui.GraphstreamBasedRenderer
 
GraphvizComponent - Class in grph.gui
 
GraphvizComponent(Grph) - Constructor for class grph.gui.GraphvizComponent
 
GraphvizImageWriter - Class in grph.io
Th default behavior is to generate PDF data via the dot command.
GraphvizImageWriter() - Constructor for class grph.io.GraphvizImageWriter
 
GraphvizImageWriter.COMMAND - Enum in grph.io
 
GraphvizImageWriter.OUTPUT_FORMAT - Enum in grph.io
 
GraphVizPNGGrphRenderer - Class in grph.gui
 
GraphVizPNGGrphRenderer(Grph) - Constructor for class grph.gui.GraphVizPNGGrphRenderer
 
GreedyChromaticNumber - Class in grph.algo.labelling
Compute the chromatic number of the given graph, with a greedy algorithm.
GreedyChromaticNumber() - Constructor for class grph.algo.labelling.GreedyChromaticNumber
 
grid(int, int) - Static method in class grph.algo.topology.ClassicalGraphs
 
grid(int, int) - Method in class grph.Grph
Connect vertices currently in the graph as a grid of dimension (w, h).
grid(int, int, boolean, boolean, boolean) - Method in class grph.Grph
Connect vertices currently in the graph as a grid of dimension (w, h).
GridTopologyGenerator - Class in grph.algo.topology
Creates a grid with diagonal lines.
GridTopologyGenerator() - Constructor for class grph.algo.topology.GridTopologyGenerator
 
grph - package grph
 
Grph - Class in grph
A full-featured graph object, exhibiting all available operations and algorithms.
Grph(String, int, int) - Constructor for class grph.Grph
 
grph.algo - package grph.algo
 
grph.algo.clustering - package grph.algo.clustering
 
grph.algo.coloring - package grph.algo.coloring
 
grph.algo.covering_packing - package grph.algo.covering_packing
 
grph.algo.degree - package grph.algo.degree
 
grph.algo.distance - package grph.algo.distance
 
grph.algo.k_shortest_paths - package grph.algo.k_shortest_paths
 
grph.algo.labelling - package grph.algo.labelling
 
grph.algo.lad - package grph.algo.lad
 
grph.algo.msp - package grph.algo.msp
 
grph.algo.ogdf - package grph.algo.ogdf
 
grph.algo.partitionning.metis - package grph.algo.partitionning.metis
 
grph.algo.search - package grph.algo.search
 
grph.algo.sort - package grph.algo.sort
 
grph.algo.sparse_cut - package grph.algo.sparse_cut
 
grph.algo.structural - package grph.algo.structural
 
grph.algo.structural.cliquer - package grph.algo.structural.cliquer
 
grph.algo.subgraph_isomorphism - package grph.algo.subgraph_isomorphism
 
grph.algo.subgraph_isomorphism.own - package grph.algo.subgraph_isomorphism.own
 
grph.algo.topology - package grph.algo.topology
 
grph.algo.topology.gsm - package grph.algo.topology.gsm
 
grph.algo.topology.rmat - package grph.algo.topology.rmat
 
grph.algo.triangles.latapi - package grph.algo.triangles.latapi
 
grph.demo - package grph.demo
 
grph.demo.perf - package grph.demo.perf
 
Grph.DIRECTION - Enum in grph
 
grph.dynamics - package grph.dynamics
 
grph.edit - package grph.edit
 
grph.gui - package grph.gui
 
grph.in_memory - package grph.in_memory
 
grph.io - package grph.io
 
grph.io.graphml - package grph.io.graphml
 
Grph.MaxIndependentSetAlgorithm - Enum in grph
Implemented Maximum Independent Set algorithms.
Grph.MinVertexCoverAlgorithm - Enum in grph
Implemented Minimum Vertex Cover algorithms.
grph.oo - package grph.oo
 
grph.path - package grph.path
 
grph.properties - package grph.properties
 
grph.report - package grph.report
 
grph.script - package grph.script
 
grph.stepper - package grph.stepper
 
grph.topology.random.genetic - package grph.topology.random.genetic
 
Grph.TYPE - Enum in grph
 
grph.util - package grph.util
 
Grphable - Interface in grph.oo
 
GrphAlgorithm<R> - Class in grph
The definition for general graph algorithms.
GrphAlgorithm() - Constructor for class grph.GrphAlgorithm
 
GrphAlgorithmCache<E> - Class in grph
A graph algorithm wrapper that cache the result computed by its underlying algorithm.
GrphAlgorithmCache(Grph, GrphAlgorithm<E>) - Constructor for class grph.GrphAlgorithmCache
 
GrphApplet - Class in <Unnamed>
 
GrphApplet() - Constructor for class GrphApplet
 
GrphBinaryReader - Class in grph.io
 
GrphBinaryReader() - Constructor for class grph.io.GrphBinaryReader
 
GrphBinaryWriter - Class in grph.io
 
GrphBinaryWriter() - Constructor for class grph.io.GrphBinaryWriter
 
GrphEditor - Interface in grph.edit
 
GrphIntSet - Interface in grph
 
GrphIntSet - Class in grph.in_memory
 
GrphIntSet(int) - Constructor for class grph.in_memory.GrphIntSet
 
GrphLogger - Class in grph
 
GrphLogger() - Constructor for class grph.GrphLogger
 
GrphPrimitives - Interface in grph
 
GrphTextReader - Class in grph.io
e0 2 1 a1 1 > 2 E9 1 4 A34 4 6 8 > 1 8
GrphTextReader() - Constructor for class grph.io.GrphTextReader
 
GrphTextWriter - Class in grph.io
 
GrphTextWriter() - Constructor for class grph.io.GrphTextWriter
 
GrphWebNotifications - Class in grph
 
GrphWebNotifications() - Constructor for class grph.GrphWebNotifications
 
GSMNetwork - Class in grph.algo.topology.gsm
 
GSMNetwork(int, int, int, Random) - Constructor for class grph.algo.topology.gsm.GSMNetwork
 
GUIShellEditor - Class in grph.edit
 
GUIShellEditor(Grph) - Constructor for class grph.edit.GUIShellEditor
 

H

HamiltonianPaths - Class in grph.algo
 
HamiltonianPaths() - Constructor for class grph.algo.HamiltonianPaths
 
has_cycles - Class in grph.script
 
has_cycles(RegularFile) - Constructor for class grph.script.has_cycles
 
hasCycles(int) - Method in class grph.Grph
Checks if this graph has a cycle, by initiating the search from the given source.
hashCode() - Method in class grph.path.AbstractPath
 
hasIncidentEdges(V) - Method in class grph.oo.ObjectGrph
 
hasLoop(int) - Method in class grph.Grph
Checks if the given vertex has self-loops on it.
hasLoop() - Method in class grph.path.AbstractPath
 
hasLoop() - Method in interface grph.path.Path
 
hasLoops() - Method in class grph.Grph
 
hasMatches(Grph, Grph) - Method in class grph.algo.subgraph_isomorphism.GraphMatchingAlgorithm
 
hasMultipleEdges() - Method in class grph.Grph
Checks if this graph is has multiple edges in it.
hasNegativeWeightCycles(Grph, SearchResult) - Method in class grph.algo.search.BellmanFordAlgorithm
 
hasNext() - Method in interface grph.algo.VEIterator
 
hasValue(int) - Method in class grph.in_memory.IncidenceList
 
haveSameValues(int, int) - Method in class grph.properties.NumericalProperty
 
haveSameValues(int, int) - Method in class grph.properties.ObjectProperty
 
haveSameValues(int, int) - Method in class grph.properties.Property
 
heavy_grph_process - Class in grph.script
 
heavy_grph_process(RegularFile) - Constructor for class grph.script.heavy_grph_process
 
highlight(Grph) - Method in class grph.Grph
Assigns the given color to all vertices and edges in the given graph.
highlight(Grph, int) - Method in class grph.Grph
 
highlight(Collection<Cluster>) - Method in class grph.Grph
 
highlight(Collection<Cluster>, boolean) - Method in class grph.Grph
 
highlightEdges(IntSet, int) - Method in class grph.Grph
Assigns the given color to all edges in the given set.
highlightEdges(IntSet) - Method in class grph.Grph
 
highlightVertex(int, int) - Method in class grph.Grph
 
highlightVertices(IntSet, int) - Method in class grph.Grph
Assigns the given color to all vertices in the given set.
highlightVertices(int...) - Method in class grph.Grph
 
highlightVertices(IntSet) - Method in class grph.Grph
Assign adequate color to the given vertices so that they distinguish clearly on graphical views of this graph.
highlightVertices(Collection<IntSet>) - Method in class grph.Grph
 
HOSTS - Static variable in class grph.Grph
 

I

i2e(int) - Method in class grph.oo.ObjectGrph
 
i2e(IntSet) - Method in class grph.oo.ObjectGrph
 
i2v(int) - Method in class grph.oo.ObjectGrph
 
i2v(IntSet) - Method in class grph.oo.ObjectGrph
 
IDipergrafsListener - Interface in grph.script
 
illustrate_topologies - Class in grph.script
 
illustrate_topologies(RegularFile) - Constructor for class grph.script.illustrate_topologies
 
In() - Constructor for class grph.algo.VertexAdjacencyAlgorithm.In
 
inacessibleVertices - Variable in class grph.Grph
 
InacessibleVerticesAlgorithm - Class in grph.algo
Compute the set of vertices that have no input edge.
InacessibleVerticesAlgorithm() - Constructor for class grph.algo.InacessibleVerticesAlgorithm
 
IncidenceList - Class in grph.in_memory
 
IncidenceList(int) - Constructor for class grph.in_memory.IncidenceList
 
incidenceMatrixAlgo - Variable in class grph.Grph
 
IncidenceMatrixAlgorithm - Class in grph.algo
Compute the incidence matrix for the given graph.
IncidenceMatrixAlgorithm() - Constructor for class grph.algo.IncidenceMatrixAlgorithm
 
Incrementlabelling - Class in grph.algo.labelling
 
Incrementlabelling(int) - Constructor for class grph.algo.labelling.Incrementlabelling
 
indexOfVertex(int) - Method in class grph.path.ArrayListPath
 
indexOfVertex(int) - Method in class grph.path.ArrayPath
 
indexOfVertex(int) - Method in interface grph.path.Path
 
indexOfVertex(int) - Method in class grph.path.PathExtender
 
indexOfVertex(int) - Method in class grph.path.SearchResultWrappedPath
 
indexOfVertex(int) - Method in class grph.path.SingletonPath
 
inet(int, double, int, long) - Static method in class grph.algo.topology.InetTopologyGenerator
 
InetTopologyGenerator - Class in grph.algo.topology
Provides a bridge to the INET topology generator (http://topology.eecs.umich.edu/inet/).
InetTopologyGenerator() - Constructor for class grph.algo.topology.InetTopologyGenerator
 
init() - Method in class GrphApplet
 
InMemoryGrph - Class in grph.in_memory
The basic data-structure.
InMemoryGrph() - Constructor for class grph.in_memory.InMemoryGrph
 
InMemoryGrph(String, boolean, Grph.DIRECTION) - Constructor for class grph.in_memory.InMemoryGrph
 
InMemoryGrph(String, int, int, Grph.DIRECTION) - Constructor for class grph.in_memory.InMemoryGrph
 
inNeighborsAlgorithm - Variable in class grph.Grph
 
InOut() - Constructor for class grph.algo.VertexAdjacencyAlgorithm.InOut
 
inOutNeighborsAlgorithm - Variable in class grph.Grph
 
IntOgdfAlgorithm - Class in grph.algo.ogdf
 
IntOgdfAlgorithm() - Constructor for class grph.algo.ogdf.IntOgdfAlgorithm
 
invalidateCachedValue() - Method in class grph.GrphAlgorithmCache
 
IrreflexiveAlgorithm - Class in grph.algo
Computes wether the given graph is irreflexive.
IrreflexiveAlgorithm() - Constructor for class grph.algo.IrreflexiveAlgorithm
 
irreflexiveAlgorithm - Variable in class grph.Grph
 
isAntigraph() - Method in class grph.Grph
Checks whether this graph is an antigraph.
isApplicable(Grph) - Method in class grph.path.AbstractPath
Checks whether this path is applicable to the given graph.
isApplicable(Grph) - Method in interface grph.path.Path
Checks whether this path is applicable to the given graph.
isBipartite() - Method in class grph.Grph
Checks if this graph is bipartite.
isCachedValueValid() - Method in class grph.GrphAlgorithmCache
 
isCacheEnabled() - Method in class grph.GrphAlgorithmCache
 
isChordal() - Method in class grph.Grph
Checks if this graph is chordal or not.
isClique(IntSet) - Method in class grph.Grph
Checks if the given set of vertices describes a clique in this graph.
isComplete() - Method in class grph.Grph
Checks if this graph is a complete graph.
isConnected() - Method in class grph.Grph
Checks if this graph is made of one single partition
isCreateDirectedEdges() - Method in class grph.io.EdgeListReader
 
isCut(IntSet, IntSet) - Method in class grph.Grph
Computes if the two given sets form a cut of this graph.
isCut(IntSet...) - Method in class grph.Grph
Computes if the given sets form a cut of this graph.
isCycle() - Method in class grph.path.AbstractPath
Checks whether this path is a cycle or not.
isCycle() - Method in interface grph.path.Path
Checks whether this path is a cycle or not.
isCyclic() - Method in class grph.Grph
Checks whether this graph is cyclic or not (o circuit in the case of digraphs).
IsCyclicAlgorithm - Class in grph.algo
Checks wether the given graph is cyclic or not.
IsCyclicAlgorithm() - Constructor for class grph.algo.IsCyclicAlgorithm
 
isCyclicAlgorithm - Variable in class grph.Grph
 
isDirected() - Method in class grph.algo.topology.RandomTreeTopologyGenerator
 
isDirected() - Method in class grph.algo.topology.RingTopologyGenerator
 
isDirected() - Method in class grph.Grph
Checks if this graph is directed or not (i.e.
isDirectedHyperEdge(int) - Method in interface grph.DirectedHyperGraph
 
isDirectedHyperEdge(int) - Method in class grph.in_memory.InMemoryGrph
Checks whether the given edge is a directed hyper edge.
isDirectedSimpleEdge(int) - Method in interface grph.DirectedSimpleGraph
 
isDirectedSimpleEdge(int, int) - Method in class grph.Grph
 
isDirectedSimpleEdge(int) - Method in class grph.in_memory.InMemoryGrph
Checks whether the given edge is a directed simple edge.
isDirectedSimpleGraph() - Method in class grph.Grph
Checks if this graph has only directed simple edges.
isDominatingSet(IntSet) - Method in class grph.Grph
Tests if the given set in a dominating set of this graph.
isElementary() - Method in class grph.path.AbstractPath
 
isElementary() - Method in interface grph.path.Path
 
isEnabled() - Method in class grph.io.DynamicsLogger
 
isHamiltonian(Grph) - Method in class grph.path.AbstractPath
Checks whether this path is hamiltonian on the given graph.
isHamiltonian(Grph) - Method in interface grph.path.Path
Checks whether this path is hamiltonian on the given graph.
isHyperEdge(int) - Method in class grph.Grph
 
isHypergraph() - Method in class grph.Grph
Checks if this graph is an hypergraph or not (i.e.
isIndependentSet(IntSet) - Method in class grph.Grph
Tests if the given set is an independent set (a.k.a.
isIrreflexive() - Method in class grph.Grph
Checks if this graph is an irreflexive graph
isIsomorphicTo(Grph) - Method in class grph.Grph
Returns true if this graph is isomorphic to the given graph, false otherwise.
isLeaf(int) - Method in class grph.Grph
Checks if the given vertex is a leaf.
isLoop(int) - Method in class grph.Grph
Checks whether the given edge is a self-loop or not.
isMatching(IntSet) - Method in class grph.Grph
Computes if the given set of edges forms a matching of this graph.
isMixed() - Method in class grph.Grph
Checks if this graph is mixed or not (i.e.
isNull() - Method in class grph.Grph
Checks if this graph is a null graph.
IsolatedVerticesAlgorithm - Class in grph.algo
Compute the set of isolated vertices.
IsolatedVerticesAlgorithm() - Constructor for class grph.algo.IsolatedVerticesAlgorithm
 
isolatedVerticesAlgorithm - Variable in class grph.Grph
 
isPrintEdges() - Method in class grph.io.EdgeListWriter
 
isReflexive() - Method in class grph.Grph
Checks if this graph is a reflexive graph.
isRegular() - Method in class grph.Grph
Checks if this graph is a regular graph.
isSetted(int) - Method in class grph.properties.Property
 
isShortestPath(Grph, NumericalProperty) - Method in class grph.path.AbstractPath
Checks whether this path is a shortest path in the given graph.
isShortestPath(Grph, NumericalProperty) - Method in interface grph.path.Path
Checks whether this path is a shortest path in the given graph.
isShortestPath(Grph, NumericalProperty) - Method in class grph.path.SearchResultWrappedPath
 
isSimple() - Method in class grph.Grph
Checks if this graph is a simple graph
isSimpleEdge(int) - Method in class grph.Grph
Checks if the given edge is a simple edge.
isSimplicial(int) - Method in class grph.Grph
Checks if the given vertex is a simplicial one.
isSink(int) - Method in class grph.Grph
Checks if the given vertex is a sink.
isSource(int) - Method in class grph.Grph
Checks if the given vertex is a source.
isSquare(double[][]) - Static method in class grph.algo.sparse_cut.Cholesky
 
isStronglyConnected() - Method in class grph.Grph
 
isSymmetric(double[][]) - Static method in class grph.algo.sparse_cut.Cholesky
 
isTree() - Method in class grph.Grph
Checks if this graph is a tree.
isTrivial() - Method in class grph.Grph
Checks if this graph is a trivial graph.
isUndirectedHyperEdge(int) - Method in class grph.in_memory.InMemoryGrph
Checks if the given edge is an undirected hyper edge.
isUndirectedHyperEdge(int) - Method in interface grph.UndirectedHyperGraph
 
isUndirectedSimpleEdge(int, int) - Method in class grph.Grph
 
isUndirectedSimpleEdge(int) - Method in class grph.in_memory.InMemoryGrph
Checks if the given edge is an undirected simple edge.
isUndirectedSimpleEdge(int) - Method in interface grph.UndirectedSimpleGraph
 
isUndirectedSimpleGraph() - Method in class grph.Grph
Checks if this graph has only undirected simple edges.
isVerbose() - Method in class grph.stepper.AbstractStepper
 
isVertexCover(IntSet) - Method in class grph.Grph
Tests if the given set in a vertex cover of this graph.
iterate(int, int) - Method in class grph.algo.distance.PageRank
Performs the given number of random walks of the given length, starting from every vertex in the graph.

K

KClosestNeighborsTopologyGenerator - Class in grph.algo.topology
Connect each node to its k closest neighbors (k > 1).
KClosestNeighborsTopologyGenerator() - Constructor for class grph.algo.topology.KClosestNeighborsTopologyGenerator
 
keyPressed(KeyEvent) - Method in class GrphApplet
 
keyReleased(KeyEvent) - Method in class GrphApplet
 
keyTyped(KeyEvent) - Method in class GrphApplet
 
KruskalAlgorithm - Class in grph.algo.msp
 
KruskalAlgorithm() - Constructor for class grph.algo.msp.KruskalAlgorithm
 
kruskalByTom(Grph, NumericalProperty) - Static method in class grph.algo.msp.KruskalAlgorithm
 
KShortestPathsAlgorithm<P extends Path> - Class in grph.algo.k_shortest_paths
 
KShortestPathsAlgorithm() - Constructor for class grph.algo.k_shortest_paths.KShortestPathsAlgorithm
 

L

LabelBasedSubgraphMatcher - Class in grph.algo.subgraph_isomorphism.own
 
LabelBasedSubgraphMatcher() - Constructor for class grph.algo.subgraph_isomorphism.own.LabelBasedSubgraphMatcher
 
LabelMatching - Class in grph.oo
 
LabelMatching() - Constructor for class grph.oo.LabelMatching
 
LAD - Class in grph.algo.lad
LAD is a program (in C) for solving the subgraph isomorphism problem, the goal of which is to decide if there exists a copy of a pattern graph in a target graph.
LAD() - Constructor for class grph.algo.lad.LAD
 
lad(Grph, Grph, LAD.MODE, boolean) - Method in class grph.algo.lad.LAD
 
LAD.MODE - Enum in grph.algo.lad
 
LADBasedFullMatching - Class in grph.algo
 
LADBasedFullMatching() - Constructor for class grph.algo.LADBasedFullMatching
 
LADReader - Class in grph.algo.lad
 
LADReader() - Constructor for class grph.algo.lad.LADReader
 
LADWriter - Class in grph.algo.lad
 
LADWriter() - Constructor for class grph.algo.lad.LADWriter
 
LatexDocument - Class in grph.report
 
LatexDocument(Directory) - Constructor for class grph.report.LatexDocument
 
LeafFilter(Grph) - Constructor for class grph.ElementFilter.LeafFilter
 
lineGraphAlg - Variable in class grph.Grph
 
LineGraphAlgorithm - Class in grph.algo
Compute the line graph of the given graph.
LineGraphAlgorithm() - Constructor for class grph.algo.LineGraphAlgorithm
 
listCachingGraphAlgorithms() - Method in class grph.Grph
Lists all graph algorithms that employ a cache.
loadOnlineGrph(String) - Static method in class grph.Grph
Loads the graph from the given URL.
logger - Static variable in class grph.Grph
 
logImpl(Object) - Method in class grph.GrphLogger
 
LoopFilter(Grph) - Constructor for class grph.ElementFilter.LoopFilter
 
LPBasedAlgorithm<R> - Class in grph.algo
 
LPBasedAlgorithm() - Constructor for class grph.algo.LPBasedAlgorithm
 
LPBasedMaximumIndependentSetAlgorithm - Class in grph.algo.covering_packing
computes the maximum independent set for the given graph (using LP)
LPBasedMaximumIndependentSetAlgorithm() - Constructor for class grph.algo.covering_packing.LPBasedMaximumIndependentSetAlgorithm
 
LPBasedMaximumMatchingAlgorithm - Class in grph.algo.covering_packing
An algorithm to solve the maximum bipartite matching problem.
LPBasedMaximumMatchingAlgorithm() - Constructor for class grph.algo.covering_packing.LPBasedMaximumMatchingAlgorithm
 
LPBasedMinimumVertexCoverAlgorithm - Class in grph.algo.covering_packing
computes the minimum vertex cover for the given graph (using LP).
LPBasedMinimumVertexCoverAlgorithm() - Constructor for class grph.algo.covering_packing.LPBasedMinimumVertexCoverAlgorithm
 
LPMaximumindependentSetAlgorithm - Variable in class grph.Grph
 
LPMaxMatchingAlgorithm - Variable in class grph.Grph
 
LPMinVertexCoverAlgorithm - Variable in class grph.Grph
 

M

main(String[]) - Static method in class grph.algo.AdjacencyMatrix
 
main(String[]) - Static method in class grph.algo.AllPaths
 
main(String[]) - Static method in class grph.algo.AntCliqueAlgorithm
 
main(String[]) - Static method in class grph.algo.BiconnectedComponents
 
main(String[]) - Static method in class grph.algo.clustering.CONID
 
main(String[]) - Static method in class grph.algo.covering_packing.BruteForceMinimumVertexCoverAlgorithm
 
main(String[]) - Static method in class grph.algo.covering_packing.FominGrandoniKratschMaximumindependentSetAlgorithm
 
main(String[]) - Static method in class grph.algo.covering_packing.LPBasedMaximumIndependentSetAlgorithm
 
main(String[]) - Static method in class grph.algo.covering_packing.LPBasedMinimumVertexCoverAlgorithm
 
main(String[]) - Static method in class grph.algo.covering_packing.NiedermeierMinimumVertexCoverAlgorithm
 
main(String[]) - Static method in class grph.algo.distance.Demo
 
main(String[]) - Static method in class grph.algo.distance.DistanceMatrix
 
main(String[]) - Static method in class grph.algo.distance.FloydWarshallAlgorithm
 
main(String[]) - Static method in class grph.algo.distance.FourSweepIterativeFringeDiameterAlgorithm
 
main(String[]) - Static method in class grph.algo.distance.GirthAlgorithm
 
main(String[]) - Static method in class grph.algo.distance.MinimumEccentricityGraphCenter
 
main(String[]) - Static method in class grph.algo.distance.StackBasedBellmanFordWeightedMatrixAlgorithm
 
main(String[]) - Static method in class grph.algo.distance.TwoSweepBFSDiameterApproximationAlgorithm
 
main(String[]) - Static method in class grph.algo.distance.TwoSweepsGraphCenter
 
main(String[]) - Static method in class grph.algo.FindAllCycles
 
main(String[]) - Static method in class grph.algo.FindAllTrianglesAlgorithm
 
main(String[]) - Static method in class grph.algo.HamiltonianPaths
 
main(String[]) - Static method in class grph.algo.IncidenceMatrixAlgorithm
 
main(String[]) - Static method in class grph.algo.IsolatedVerticesAlgorithm
 
main(String[]) - Static method in class grph.algo.k_shortest_paths.DisjointKShortestPaths
 
main(String[]) - Static method in class grph.algo.k_shortest_paths.RandomWalkBasedKShortestPaths
 
main(String[]) - Static method in class grph.algo.k_shortest_paths.YenTopKShortestPathsAlgorithm
 
main(String[]) - Static method in class grph.algo.labelling.GreedyChromaticNumber
 
main(String[]) - Static method in class grph.algo.labelling.Relabelling
 
main(String[]) - Static method in class grph.algo.lad.DirectedLAD
 
main(String[]) - Static method in class grph.algo.lad.DirectedLADWriter
 
main(String[]) - Static method in class grph.algo.lad.LADWriter
 
main(String[]) - Static method in class grph.algo.lad.UndirectedLAD
 
main(String[]) - Static method in class grph.algo.LADBasedFullMatching
 
main(String[]) - Static method in class grph.algo.MaxFlowAlgorithm
 
main(String[]) - Static method in class grph.algo.msp.KruskalAlgorithm
 
main(String[]) - Static method in class grph.algo.MultiThreadProcessing
 
main(String[]) - Static method in class grph.algo.ogdf.OGDFDiameterAlgorithm
 
main(String[]) - Static method in class grph.algo.ogdf.OGDFPlanarityAlgorithm
 
main(String[]) - Static method in class grph.algo.ogdf.OGDFWriter
 
main(String[]) - Static method in class grph.algo.partitionning.metis.MetisWriter
 
main(String[]) - Static method in class grph.algo.Roy_WarshallMethod
 
main(String[]) - Static method in class grph.algo.search.BellmanFordAlgorithm
 
main(String[]) - Static method in class grph.algo.search.BFSAlgorithm
 
main(String[]) - Static method in class grph.algo.search.DFSAlgorithm
 
main(String[]) - Static method in class grph.algo.search.DijkstraAlgorithm
 
main(String[]) - Static method in class grph.algo.search.DistanceListsBasedDiameterAlgorithm
 
main(String[]) - Static method in class grph.algo.search.RandomSearch
 
main(String[]) - Static method in class grph.algo.search.StackBasedBellmanFordAlgorithm
 
main(String[]) - Static method in class grph.algo.sort.OutDegreeSorter
 
main(String[]) - Static method in class grph.algo.SpanningTree
 
main(String[]) - Static method in class grph.algo.sparse_cut.Cholesky
 
main(String[]) - Static method in class grph.algo.sparse_cut.SparseCutAlgorithm
 
main(String[]) - Static method in class grph.algo.structural.ChordalityTestAlgorithm
 
main(String[]) - Static method in class grph.algo.structural.cliquer.Cliquer
 
main(String[]) - Static method in class grph.algo.structural.cliquer.FindAllCliques
 
main(String[]) - Static method in class grph.algo.structural.TreenessAlgorithm
 
main(String[]) - Static method in class grph.algo.subgraph_isomorphism.own.Demo
 
main(String[]) - Static method in class grph.algo.subgraph_isomorphism.own.EdgeLabelBasedSubgraphMatcher
 
main(String[]) - Static method in class grph.algo.subgraph_isomorphism.own.FindAllCycles
 
main(String[]) - Static method in class grph.algo.subgraph_isomorphism.own.SubgraphSearch
 
main(String[]) - Static method in class grph.algo.subgraph_isomorphism.own.VertexLabelBasedSubgraphMatcher
 
main(String[]) - Static method in class grph.algo.Tarjan
 
main(String[]) - Static method in class grph.algo.topology.BriteTopologyGenerator
 
main(String[]) - Static method in class grph.algo.topology.GNMTopologyGenerator
 
main(String[]) - Static method in class grph.algo.topology.GNPTopologyGenerator
 
main(String[]) - Static method in class grph.algo.topology.gsm.GSMNetwork
 
main(String[]) - Static method in class grph.algo.topology.gsm.TreeOfRingsWirelessBackhaul
 
main(String[]) - Static method in class grph.algo.topology.gsm.WirelessBackhaul
 
main(String[]) - Static method in class grph.algo.topology.KClosestNeighborsTopologyGenerator
 
main(String[]) - Static method in class grph.algo.topology.PlanarGraphTopologyGenerator
 
main(String[]) - Static method in class grph.algo.topology.RandomNewmanWattsStrogatzTopologyGenerator
 
main(String[]) - Static method in class grph.algo.topology.RandomTreeTopologyGenerator
 
main(String[]) - Static method in class grph.algo.topology.RingTopologyGenerator
 
main(String[]) - Static method in class grph.algo.topology.rmat.RmatTopologyGenerator
 
main(String[]) - Static method in class grph.algo.TransitiveClosure
 
main(String[]) - Static method in class grph.algo.triangles.latapi.MatthieuLatapyTriangleAlgorithm
 
main(String[]) - Static method in class grph.demo.Assertions
 
main(String[]) - Static method in class grph.demo.Colors
 
main(String[]) - Static method in class grph.demo.ComputeAllPairShortestPaths
 
main(String[]) - Static method in class grph.demo.ComputeDiameter
 
main(String[]) - Static method in class grph.demo.ComputeOneShortestPath
 
main(String[]) - Static method in class grph.demo.CreateGraph
 
main(String[]) - Static method in class grph.demo.CreatePath
 
main(String[]) - Static method in class grph.demo.CreateRandomGraph
 
main(String[]) - Static method in class grph.demo.CreateRing
 
main(String[]) - Static method in class grph.demo.David
 
main(String[]) - Static method in class grph.demo.DynamicGraph
 
main(String[]) - Static method in class grph.demo.FileWrite
 
main(String[]) - Static method in class grph.demo.GenerateGLP
 
main(String[]) - Static method in class grph.demo.GenerateGrid
 
main(String[]) - Static method in class grph.demo.perf.BigGrid
 
main(String[]) - Static method in class grph.demo.SimpleCodes
 
main(String[]) - Static method in class grph.edit.GUIShellEditor
 
main(String[]) - Static method in class grph.Grph
 
main(String[]) - Static method in class grph.gui.GraphstreamBasedRenderer
 
main(String[]) - Static method in class grph.gui.GraphvizComponent
 
main(String[]) - Static method in class grph.in_memory.InMemoryGrph
 
main(String[]) - Static method in class grph.in_memory.SimpleEdgeIncidenceList
 
main(String[]) - Static method in class grph.io.DimacsWriter
 
main(String[]) - Static method in class grph.io.DotWriter
 
main(String[]) - Static method in class grph.io.graphml.GraphMLWriter
 
main(String[]) - Static method in class grph.io.GraphvizImageWriter
 
main(String[]) - Static method in class grph.io.GrphTextWriter
 
main(String[]) - Static method in class grph.io.RDFTurtleWriter
 
main(String[]) - Static method in class grph.oo.ObjectGrph
 
main(String[]) - Static method in class grph.oo.ObjectPath
 
main(String[]) - Static method in class grph.path.ArrayListPath
 
main(String[]) - Static method in class grph.path.ArrayPath
 
main(String[]) - Static method in class grph.path.PathExtender
 
main(String[]) - Static method in class grph.path.SearchResultWrappedPath
 
main(String[]) - Static method in class grph.properties.NumericalProperty
 
main(String[]) - Static method in class grph.report.Report
 
main(String[]) - Static method in class grph.RunTests
 
main(String[]) - Static method in class grph.script.add_to_algorithm_repository
 
main(String[]) - Static method in class grph.script.biggest_graph_possible
 
main(String[]) - Static method in class grph.script.convert
 
main(String[]) - Static method in class grph.script.demo_lifegame
 
main(String[]) - Static method in class grph.script.heavy_grph_process
 
main(String[]) - Static method in class grph.script.render_graphstream
 
main(String[]) - Static method in class grph.script.render_shortest_path
 
main(String[]) - Static method in class grph.stepper.ConsoleStepper
 
main(String[]) - Static method in class grph.stepper.SwingStepper
 
main(String[]) - Static method in class grph.stepper.Tet
 
main(String[]) - Static method in class grph.topology.random.genetic.Demo
 
main2(String[]) - Static method in class grph.algo.partitionning.metis.Gpmetis
 
main2(String[]) - Static method in class grph.oo.ObjectGrph
 
Matching - Class in grph.util
 
Matching() - Constructor for class grph.util.Matching
 
MatrixBasedNumberOfTrianglesAlgorithm - Class in grph.algo
 
MatrixBasedNumberOfTrianglesAlgorithm() - Constructor for class grph.algo.MatrixBasedNumberOfTrianglesAlgorithm
 
MatthieuLatapyTriangleAlgorithm - Class in grph.algo.triangles.latapi
Fast and Compact Algorithms for Triangle Problems in Very Large (Sparse (Power-Law)) Graphs.
MatthieuLatapyTriangleAlgorithm() - Constructor for class grph.algo.triangles.latapi.MatthieuLatapyTriangleAlgorithm
 
MatthieuLatapyTriangleAlgorithm.ALGORITHM - Enum in grph.algo.triangles.latapi
 
maxDistance() - Method in class grph.algo.search.SearchResult
 
MaxFlowAlgorithm - Class in grph.algo
 
MaxFlowAlgorithm() - Constructor for class grph.algo.MaxFlowAlgorithm
 
MaxFlowAlgorithmResult - Class in grph.algo
 
MaxFlowAlgorithmResult(Result, int, int) - Constructor for class grph.algo.MaxFlowAlgorithmResult
 
MaxInEdgeDegreeAlgorithm - Class in grph.algo.degree
 
MaxInEdgeDegreeAlgorithm() - Constructor for class grph.algo.degree.MaxInEdgeDegreeAlgorithm
 
maxInEdgeDegreeAlgorithm - Variable in class grph.Grph
 
MaxInVertexDegreeAlgorithm - Class in grph.algo.degree
 
MaxInVertexDegreeAlgorithm() - Constructor for class grph.algo.degree.MaxInVertexDegreeAlgorithm
 
maxInVertexDegreeAlgorithm - Variable in class grph.Grph
 
MaxOutEdgeDegreeAlgorithm - Class in grph.algo.degree
 
MaxOutEdgeDegreeAlgorithm() - Constructor for class grph.algo.degree.MaxOutEdgeDegreeAlgorithm
 
maxOutEdgeDegreeAlgorithm - Variable in class grph.Grph
 
MaxOutVertexDegreeAlgorithm - Class in grph.algo.degree
 
MaxOutVertexDegreeAlgorithm() - Constructor for class grph.algo.degree.MaxOutVertexDegreeAlgorithm
 
maxOutVertexDegreeAlgorithm - Variable in class grph.Grph
 
merge(Grph) - Method in class grph.Grph
 
MetisWriter - Class in grph.algo.partitionning.metis
 
MetisWriter() - Constructor for class grph.algo.partitionning.metis.MetisWriter
 
Metric - Class in grph.report
 
Metric(String) - Constructor for class grph.report.Metric
 
Metric(String, Object) - Constructor for class grph.report.Metric
 
Metric(String, Object, String) - Constructor for class grph.report.Metric
 
MinimumEccentricityGraphCenter - Class in grph.algo.distance
 
MinimumEccentricityGraphCenter() - Constructor for class grph.algo.distance.MinimumEccentricityGraphCenter
 
MinInEdgeDegreeAlgorithm - Class in grph.algo.degree
 
MinInEdgeDegreeAlgorithm() - Constructor for class grph.algo.degree.MinInEdgeDegreeAlgorithm
 
minInEdgeDegreeAlgorithm - Variable in class grph.Grph
 
MinInVertexDegreeAlgorithm - Class in grph.algo.degree
 
MinInVertexDegreeAlgorithm() - Constructor for class grph.algo.degree.MinInVertexDegreeAlgorithm
 
minInVertexDegreeAlgorithm - Variable in class grph.Grph
 
MinOutEdgeDegreeAlgorithm - Class in grph.algo.degree
 
MinOutEdgeDegreeAlgorithm() - Constructor for class grph.algo.degree.MinOutEdgeDegreeAlgorithm
 
minOutEdgeDegreeAlgorithm - Variable in class grph.Grph
 
MinOutVertexDegreeAlgorithm - Class in grph.algo.degree
 
MinOutVertexDegreeAlgorithm() - Constructor for class grph.algo.degree.MinOutVertexDegreeAlgorithm
 
minOutVertexDegreeAlgorithm - Variable in class grph.Grph
 
MultigraphnessAlgorithm - Class in grph.algo.structural
 
MultigraphnessAlgorithm() - Constructor for class grph.algo.structural.MultigraphnessAlgorithm
 
multigraphnessAlgorithm - Variable in class grph.Grph
 
MultigraphnessResult - Class in grph.algo.structural
 
MultigraphnessResult() - Constructor for class grph.algo.structural.MultigraphnessResult
 
MultiThreadProcessing - Class in grph.algo
 
MultiThreadProcessing(IntSet) - Constructor for class grph.algo.MultiThreadProcessing
 
MultiThreadProcessing(IntSet, int) - Constructor for class grph.algo.MultiThreadProcessing
 
mutate(Grph, Random) - Method in class grph.topology.random.genetic.DirectedSimpleEdgeAdditionMutationOperator
 
mutate(Grph, Random) - Method in class grph.topology.random.genetic.EdgeRemovalMutation
 
mutate(Grph, Random) - Method in class grph.topology.random.genetic.UndirectedSimpleEdgeAdditionMutation
 
mutate(Grph, Random) - Method in class grph.topology.random.genetic.VertexAdditionMutation
 
mutate(Grph, Random) - Method in class grph.topology.random.genetic.VertexRemovalMutation
 

N

next() - Method in interface grph.algo.VEIterator
 
NiedermeierMinimumVertexCoverAlgorithm - Class in grph.algo.covering_packing
 
NiedermeierMinimumVertexCoverAlgorithm() - Constructor for class grph.algo.covering_packing.NiedermeierMinimumVertexCoverAlgorithm
 
NiedermeierMinimumVertexCoverAlgorithm - Variable in class grph.Grph
 
numberOfTriangles - Variable in class grph.algo.triangles.latapi.Result
 
NumericalProperty - Class in grph.properties
 
NumericalProperty(String) - Constructor for class grph.properties.NumericalProperty
 
NumericalProperty(String, int, long) - Constructor for class grph.properties.NumericalProperty
 

O

ObjectGrph<V,E> - Class in grph.oo
This class provides an object-oriented interface to the functionality provided by the Grph library.
ObjectGrph() - Constructor for class grph.oo.ObjectGrph
 
ObjectGrph(int, int) - Constructor for class grph.oo.ObjectGrph
 
ObjectPath<V,E> - Class in grph.oo
 
ObjectPath(Path, ObjectGrph<V, E>) - Constructor for class grph.oo.ObjectPath
 
ObjectProperty<T> - Class in grph.properties
 
ObjectProperty(String, int) - Constructor for class grph.properties.ObjectProperty
 
OGDFAlgorithm<R> - Class in grph.algo.ogdf
 
OGDFAlgorithm() - Constructor for class grph.algo.ogdf.OGDFAlgorithm
 
OGDFDiameterAlgorithm - Class in grph.algo.ogdf
 
OGDFDiameterAlgorithm() - Constructor for class grph.algo.ogdf.OGDFDiameterAlgorithm
 
OGDFPlanarityAlgorithm - Class in grph.algo.ogdf
 
OGDFPlanarityAlgorithm() - Constructor for class grph.algo.ogdf.OGDFPlanarityAlgorithm
 
OGDFReader - Class in grph.algo.ogdf
 
OGDFReader() - Constructor for class grph.algo.ogdf.OGDFReader
 
OGDFWriter - Class in grph.algo.ogdf
 
OGDFWriter() - Constructor for class grph.algo.ogdf.OGDFWriter
 
Operator - Class in grph.algo.topology.gsm
 
Operator() - Constructor for class grph.algo.topology.gsm.Operator
 
OreTheorem - Class in grph.algo.structural
Ore theorem considers the sum of the degrees of any two non-adjacent vertices: if this sum is always at least equal to the total number of vertices in the graph, then the graph is Hamiltonian.
OreTheorem() - Constructor for class grph.algo.structural.OreTheorem
 
Out() - Constructor for class grph.algo.VertexAdjacencyAlgorithm.Out
 
OutDegreeSorter - Class in grph.algo.sort
 
OutDegreeSorter() - Constructor for class grph.algo.sort.OutDegreeSorter
 
outNeighborsAlgorithm - Variable in class grph.Grph
 
OutVertexAdjacencyAsIDSetsAlgorithm - Class in grph.algo
Computes an array of IDSets representing the adjacency for all vertices in the graph
OutVertexAdjacencyAsIDSetsAlgorithm() - Constructor for class grph.algo.OutVertexAdjacencyAsIDSetsAlgorithm
 

P

P() - Constructor for class grph.io.graphml.GraphMLWriter.P
 
PageRank - Class in grph.algo.distance
The page rank value for every vertex in the graph.
PageRank(Grph, Random) - Constructor for class grph.algo.distance.PageRank
Creates an empty page rank for the given graph, using the given random number generator.
ParseException - Exception in grph.io
 
ParseException(String, int) - Constructor for exception grph.io.ParseException
 
parseNumber(String, int) - Static method in class grph.io.AbstractGraphReader
 
parseOutputData(int, String) - Static method in class grph.algo.sparse_cut.SparseCutAlgorithm
 
path(int) - Static method in class grph.algo.topology.ClassicalGraphs
Constructs the path graph on n vertices, Pn.
Path - Interface in grph.path
A ion of path.
PathExtender - Class in grph.path
 
PathExtender(Path, int, int) - Constructor for class grph.path.PathExtender
 
PathNotModifiableException - Exception in grph.path
 
PathNotModifiableException() - Constructor for exception grph.path.PathNotModifiableException
 
Paths - Class in grph
 
Paths() - Constructor for class grph.Paths
 
pathToString(Path, Property, Property) - Method in class grph.algo.subgraph_isomorphism.own.EdgeLabelBasedSubgraphMatcher
 
pathToString(Path, Property, Property) - Method in class grph.algo.subgraph_isomorphism.own.LabelBasedSubgraphMatcher
 
pathToString(Path, Property, Property) - Method in class grph.algo.subgraph_isomorphism.own.VertexLabelBasedSubgraphMatcher
 
pattern2graph() - Method in class grph.util.Matching
 
pattern2graph(int, int) - Method in class grph.util.Matching
 
perform(Grph, Random) - Static method in class grph.algo.topology.PlanarGraphTopologyGenerator
 
performRandomTopologicalChange(Random) - Method in class grph.Grph
Performs a random change in this graph.
permitsSameTrip(Path) - Method in class grph.path.AbstractPath
Checks whether the given path has the same source and destination has this path.
permitsSameTrip(Path) - Method in interface grph.path.Path
Checks whether the given path has the same source and destination has this path.
PetersenGraph() - Static method in class grph.algo.topology.ClassicalGraphs
Constructs the Petersen graph.
petersenGraph(int, int) - Static method in class grph.algo.topology.PetersonGraph
Generates a Generates the generalized Pertersen graph, formed by connecting the vertices of a regular polygon to the corresponding vertices of a star polygon.
PetersonGraph - Class in grph.algo.topology
 
PetersonGraph() - Constructor for class grph.algo.topology.PetersonGraph
 
pickRandomElement(Random) - Method in interface grph.GrphIntSet
 
PlanarGraphTopologyGenerator - Class in grph.algo.topology
 
PlanarGraphTopologyGenerator() - Constructor for class grph.algo.topology.PlanarGraphTopologyGenerator
 
postOnTheWeb() - Method in class grph.Grph
Post this graph this Grph website.
power(AdjacencyMatrix, int) - Static method in class grph.algo.AdjacencyMatrix
 
PredecessorMatrix - Class in grph.algo.distance
 
PredecessorMatrix(int, int) - Constructor for class grph.algo.distance.PredecessorMatrix
 
PredecessorMatrix(SearchResult[]) - Constructor for class grph.algo.distance.PredecessorMatrix
 
PredecessorMatrixAlgorithm - Class in grph.algo.distance
 
PredecessorMatrixAlgorithm() - Constructor for class grph.algo.distance.PredecessorMatrixAlgorithm
 
predecessors - Variable in class grph.algo.search.SearchResult
 
print(PrintStream, String) - Method in class grph.io.DynamicsLogger
 
print(String) - Method in class grph.stepper.AbstractStepper
 
printExampleCode() - Static method in class grph.io.DimacsWriter
 
printGraph(Grph, PrintStream) - Method in class grph.algo.lad.DirectedLADWriter
 
printGraph(Grph, PrintStream) - Method in class grph.algo.lad.LADWriter
 
printGraph(Grph, PrintStream) - Method in class grph.algo.ogdf.OGDFWriter
 
printGraph(Grph, PrintStream) - Method in class grph.algo.partitionning.metis.MetisWriter
 
printGraph(Grph, PrintStream) - Method in class grph.io.AbstractGraphTextWriter
 
printGraph(Grph) - Method in class grph.io.AbstractGraphTextWriter
 
printGraph(Grph, PrintStream) - Method in class grph.io.ADJTextWriter
 
printGraph(Grph, PrintStream) - Method in class grph.io.DGSWriter
 
printGraph(Grph, PrintStream) - Method in class grph.io.DimacsWriter
 
printGraph(Grph, PrintStream) - Method in class grph.io.DotWriter
 
printGraph(Grph, boolean, OutputStream) - Method in class grph.io.DotWriter
 
printGraph(Grph, PrintStream) - Method in class grph.io.EdgeListWriter
 
printGraph(Grph, PrintStream) - Method in class grph.io.GMLWriter
 
printGraph(Grph, PrintStream) - Method in class grph.io.graphml.GraphMLWriter
 
printGraph(Grph, PrintStream) - Method in class grph.io.GrphTextWriter
 
printGraph(Grph, PrintStream, boolean, boolean) - Method in class grph.io.GrphTextWriter
 
printGraph(Grph, PrintStream) - Method in class grph.io.RDFTurtleWriter
 
printImpl(String) - Method in class grph.stepper.AbstractStepper
 
printImpl(String) - Method in class grph.stepper.ConsoleStepper
 
printImpl(String) - Method in class grph.stepper.SwingStepper
 
processEvent(AWTEvent) - Method in class GrphApplet
 
processResult(Result) - Method in class grph.algo.covering_packing.LPBasedMaximumMatchingAlgorithm
 
processResult(Result) - Method in class grph.algo.LPBasedAlgorithm
 
processStdout(String) - Method in class grph.algo.ogdf.BooleanOGDFAlgorithm
 
processStdout(String) - Method in class grph.algo.ogdf.IntOgdfAlgorithm
 
processStdout(String) - Method in class grph.algo.ogdf.OGDFAlgorithm
 
produce() - Method in class grph.algo.FindAllCycles
 
Property - Class in grph.properties
 
Property(String) - Constructor for class grph.properties.Property
 
PropertyFilenameCalculator - Interface in grph.report
 
PropertyListener - Interface in grph.properties
 
prune(boolean) - Method in class grph.Grph
Prunes this graph (remove leaves)
put(Object, Object, Object...) - Method in class grph.Cache
 

R

RadiusAlgorithm - Class in grph.algo
 
RadiusAlgorithm() - Constructor for class grph.algo.RadiusAlgorithm
 
radiusAlgorithm - Variable in class grph.Grph
 
randomBipartiteGraph(int, int, double) - Static method in class grph.algo.topology.ClassicalGraphs
Constructs a random bipartite graph.
randomize(IntSet, Random) - Method in class grph.properties.NumericalProperty
 
RandomizedGridTopology - Class in grph.algo.topology
Creates a grid with diagonal lines.
RandomizedGridTopology() - Constructor for class grph.algo.topology.RandomizedGridTopology
 
RandomizedTopologyTransform - Class in grph.algo.topology
 
RandomizedTopologyTransform() - Constructor for class grph.algo.topology.RandomizedTopologyTransform
 
RandomNewmanWattsStrogatzTopologyGenerator - Class in grph.algo.topology
From the SageMath documentation: First create a ring over n nodes.
RandomNewmanWattsStrogatzTopologyGenerator() - Constructor for class grph.algo.topology.RandomNewmanWattsStrogatzTopologyGenerator
 
RandomSearch - Class in grph.algo.search
 
RandomSearch(Grph, int, Grph.DIRECTION, Random, int, GraphSearchListener) - Constructor for class grph.algo.search.RandomSearch
 
RandomTraversalButVisitOnlyOnce - Class in grph.algo.search
 
RandomTraversalButVisitOnlyOnce(Grph, int, Grph.DIRECTION, Random, int) - Constructor for class grph.algo.search.RandomTraversalButVisitOnlyOnce
 
RandomTreeTopologyGenerator - Class in grph.algo.topology
 
RandomTreeTopologyGenerator() - Constructor for class grph.algo.topology.RandomTreeTopologyGenerator
 
randomWalk(int, int) - Method in class grph.algo.distance.PageRank
Performs one single random walk of the given length, starting from the given source.
RandomWalkBasedKShortestPaths - Class in grph.algo.k_shortest_paths
 
RandomWalkBasedKShortestPaths() - Constructor for class grph.algo.k_shortest_paths.RandomWalkBasedKShortestPaths
 
RDFTurtleWriter - Class in grph.io
 
RDFTurtleWriter() - Constructor for class grph.io.RDFTurtleWriter
 
readGraph(InputStream) - Method in class grph.algo.lad.LADReader
 
readGraph(InputStream) - Method in class grph.algo.ogdf.OGDFReader
 
readGraph(InputStream) - Method in class grph.io.AbstractGraphReader
 
readGraph(RegularFile) - Method in class grph.io.AbstractGraphReader
 
readGraph(String) - Method in class grph.io.AbstractGraphReader
 
readGraph(byte[]) - Method in class grph.io.AbstractGraphReader
 
readGraph(InputStream) - Method in class grph.io.ADJTextReader
 
readGraph(InputStream) - Method in class grph.io.DimacsReader
 
readGraph(InputStream) - Method in class grph.io.EdgeListReader
 
readGraph(InputStream) - Method in class grph.io.graphml.GraphMLReader
 
readGraph(InputStream, Class, Class) - Method in class grph.io.graphml.GraphMLReader
 
readGraph(InputStream) - Method in class grph.io.GrphBinaryReader
 
readGraph(InputStream) - Method in class grph.io.GrphTextReader
 
ReflexivityAlgorithm - Class in grph.algo.structural
 
ReflexivityAlgorithm() - Constructor for class grph.algo.structural.ReflexivityAlgorithm
 
reflexivityAlgorithm - Variable in class grph.Grph
 
RegularityAlgorithm - Class in grph.algo.structural
 
RegularityAlgorithm() - Constructor for class grph.algo.structural.RegularityAlgorithm
 
regularityAlgorithm - Variable in class grph.Grph
 
Relabelling - Class in grph.algo.labelling
produces a graph with the same topology but relabelled.
Relabelling() - Constructor for class grph.algo.labelling.Relabelling
 
remove(int) - Method in class grph.in_memory.GrphIntSet
 
remove(int, int) - Method in class grph.in_memory.IncidenceList
 
removeEdge(int) - Method in interface grph.EdgeSet
 
removeEdge(int, int) - Method in class grph.in_memory.InMemoryGrph
 
removeEdge(int) - Method in class grph.in_memory.InMemoryGrph
Remove the given edge from the graph.
removeEdge(E) - Method in class grph.oo.ObjectGrph
 
removeEdge(int, int) - Method in interface grph.UnqualifiedGraph
 
removeEdges(IntSet) - Method in class grph.Grph
Removes the given vertices from the graph.
removeFromDirectedHyperEdgeHead(int, int) - Method in interface grph.DirectedHyperGraph
 
removeFromDirectedHyperEdgeHead(int, int) - Method in class grph.in_memory.InMemoryGrph
 
removeFromDirectedHyperEdgeTail(int, int) - Method in interface grph.DirectedHyperGraph
 
removeFromDirectedHyperEdgeTail(int, int) - Method in class grph.in_memory.InMemoryGrph
 
removeFromHyperEdge(int, int) - Method in class grph.in_memory.InMemoryGrph
Removes the given vertex from the given hyper-edge.
removeFromHyperEdge(int, int) - Method in interface grph.UndirectedHyperGraph
 
removeVertex(int) - Method in class grph.in_memory.InMemoryGrph
Removes the given vertex from the graph.
removeVertex(V) - Method in class grph.oo.ObjectGrph
 
removeVertex(int) - Method in interface grph.VertexSet
 
removeVertices(int...) - Method in class grph.Grph
Removes the given vertices from the graph.
removeVertices(IntPredicate, boolean) - Method in class grph.Grph
Removes all vertices matching the given filter.
removeVertices(IntSet) - Method in class grph.Grph
Deletes the given vertices from the graph.
render() - Method in class grph.algo.distance.PageRank
Graphically renders this page rank on the graph.
render_graphstream - Class in grph.script
 
render_graphstream(RegularFile) - Constructor for class grph.script.render_graphstream
 
render_shortest_path - Class in grph.script
 
render_shortest_path(RegularFile) - Constructor for class grph.script.render_shortest_path
 
repaint() - Method in class grph.gui.GraphvizComponent
 
report() - Method in class grph.Grph
Computes a report for this graph.
Report - Class in grph.report
 
Report(Grph) - Constructor for class grph.report.Report
 
Result - Class in grph.algo.triangles.latapi
 
Result() - Constructor for class grph.algo.triangles.latapi.Result
 
reverse() - Method in class grph.path.ArrayListPath
 
reverse() - Method in class grph.path.ArrayPath
 
reverse() - Method in interface grph.path.Path
 
reverse() - Method in class grph.path.PathExtender
 
reverse() - Method in class grph.path.SearchResultWrappedPath
 
reverse() - Method in class grph.path.SingletonPath
 
revertEdge(int) - Method in class grph.Grph
 
ring(Grph, IntSet, boolean) - Static method in class grph.algo.topology.RingTopologyGenerator
 
ring(Grph, boolean) - Static method in class grph.algo.topology.RingTopologyGenerator
 
ring(boolean) - Method in class grph.Grph
 
ring(IntSet, boolean) - Method in class grph.Grph
 
ring() - Method in class grph.Grph
Creates an undirected ring consisting of the vertices already in the graph.
RingTopologyGenerator - Class in grph.algo.topology
Link the given nodes as a chain.
RingTopologyGenerator() - Constructor for class grph.algo.topology.RingTopologyGenerator
 
rmat(Grph, int, double, double, double, int, int, int) - Static method in class grph.algo.topology.rmat.RmatTopologyGenerator
 
RmatTopologyGenerator - Class in grph.algo.topology.rmat
 
RmatTopologyGenerator() - Constructor for class grph.algo.topology.rmat.RmatTopologyGenerator
 
rnws(int, double) - Method in class grph.Grph
Connects the vertices in the graph according to the Random-Newman-Watts-Strogatz topology generation scheme.
rnws(int, int, double) - Method in class grph.Grph
 
Roy_WarshallMethod - Class in grph.algo
 
Roy_WarshallMethod() - Constructor for class grph.algo.Roy_WarshallMethod
 
run(int, int) - Method in class grph.algo.MultiThreadProcessing
 
runScript(CommandLine) - Method in class grph.script.AbstractGraphOperation
 
runScript(CommandLine, Grph) - Method in class grph.script.AbstractGraphOperation
 
runScript(CommandLine) - Method in class grph.script.add_to_algorithm_repository
 
runScript(CommandLine) - Method in class grph.script.biggest_graph_possible
 
runScript(CommandLine) - Method in class grph.script.console
 
runScript(CommandLine, Grph) - Method in class grph.script.convert
 
runScript(CommandLine) - Method in class grph.script.demo_lifegame
 
runScript(CommandLine, Grph) - Method in class grph.script.has_cycles
 
runScript(CommandLine) - Method in class grph.script.heavy_grph_process
 
runScript(CommandLine) - Method in class grph.script.illustrate_topologies
 
runScript(CommandLine, Grph) - Method in class grph.script.render_graphstream
 
runScript(CommandLine, Grph) - Method in class grph.script.render_shortest_path
 
RunTests - Class in grph
 
RunTests() - Constructor for class grph.RunTests
 

S

scalarProduct(double[], double[]) - Static method in class grph.algo.sparse_cut.SparseCutAlgorithm
 
search(int, NumericalProperty) - Method in class grph.Grph
 
searchCompleted() - Method in interface grph.algo.search.GraphSearchListener
 
SearchResult - Class in grph.algo.search
 
SearchResult(int) - Constructor for class grph.algo.search.SearchResult
 
SearchResultWrappedPath - Class in grph.path
 
SearchResultWrappedPath(SearchResult, int, int) - Constructor for class grph.path.SearchResultWrappedPath
 
searchStarted() - Method in interface grph.algo.search.GraphSearchListener
 
second - Variable in class grph.VertexPair
 
setA(double) - Method in class grph.algo.topology.rmat.RmatTopologyGenerator
 
setAcceptLoops(boolean) - Method in class grph.algo.topology.ErdosRenyiRandomizedScheme
 
setAlgo(BriteTopologyGenerator.ALGO) - Method in class grph.algo.topology.BriteTopologyGenerator
 
setAlgorithm(MatthieuLatapyTriangleAlgorithm.ALGORITHM) - Method in class grph.algo.triangles.latapi.MatthieuLatapyTriangleAlgorithm
 
setAllowsMultipleEdges(boolean) - Method in class grph.io.EdgeListReader
 
setAllValues(IntSet, T) - Method in class grph.properties.ObjectProperty
 
setB(double) - Method in class grph.algo.topology.rmat.RmatTopologyGenerator
 
setBeta(double) - Method in class grph.algo.topology.GLPIssamTopologyGenerator
 
setbWBounds(double, double) - Method in class grph.algo.topology.BriteTopologyGenerator
 
setBwDist(BriteTopologyGenerator.BWDist) - Method in class grph.algo.topology.BriteTopologyGenerator
 
setC(double) - Method in class grph.algo.topology.rmat.RmatTopologyGenerator
 
setCachedValue(E) - Method in class grph.GrphAlgorithmCache
 
setCacheEnabled(boolean) - Method in class grph.GrphAlgorithmCache
 
setCenter(int) - Method in class grph.algo.topology.StarTopologyGenerator
 
setColor(int, Color) - Method in class ColorMap
 
setColor(Grph, int) - Method in class grph.path.AbstractPath
Assigns the given color to all vertices in this path, when applied to the given graph.
setColor(Grph, int) - Method in interface grph.path.Path
Assigns the given color to all vertices in this path, when applied to the given graph.
setComment(String) - Method in class grph.report.Metric
 
setConstraints(Grph, LP) - Method in class grph.algo.covering_packing.LPBasedMaximumMatchingAlgorithm
 
setConstraints(Grph, LP) - Method in class grph.algo.StructuredLPBasedAlgorithm
 
setCreateDirectedEdges(boolean) - Method in class grph.io.EdgeListReader
 
setDefaultEdgeColor(int) - Method in class ColorMap
 
setDefaultVertexColor(int) - Method in class ColorMap
 
setDirected(boolean) - Method in class grph.algo.topology.RandomTreeTopologyGenerator
 
setDirected(boolean) - Method in class grph.algo.topology.RingTopologyGenerator
 
setE(int) - Method in class grph.algo.topology.rmat.RmatTopologyGenerator
 
setEdgeLabel(E, String) - Method in class grph.oo.ObjectGrph
 
setEdgeProbability(float) - Method in class grph.algo.topology.RandomizedGridTopology
 
setEdgesColor(NumericalProperty) - Method in class grph.Grph
 
setEdgesLabel(Property) - Method in class grph.Grph
 
setEdgesStyle(NumericalProperty) - Method in class grph.Grph
 
setEdgesWidth(NumericalProperty) - Method in class grph.Grph
 
setEmptySet(int) - Method in class grph.in_memory.IncidenceList
 
setEnabled(boolean) - Method in class grph.io.DynamicsLogger
 
setFractionOfDegreeOneNodes(double) - Method in class grph.algo.topology.InetTopologyGenerator
 
setGenerateDiagonal(boolean) - Method in class grph.algo.topology.GridTopologyGenerator
 
setGenerateDiagonal(boolean) - Method in class grph.algo.topology.RandomizedGridTopology
 
setGenerateSecondaryDiagonal(boolean) - Method in class grph.algo.topology.GridTopologyGenerator
 
setGenerateSecondaryDiagonal(boolean) - Method in class grph.algo.topology.RandomizedGridTopology
 
setGrowthType(BriteTopologyGenerator.GrowthType) - Method in class grph.algo.topology.BriteTopologyGenerator
 
setGrphID(int) - Method in interface grph.oo.Grphable
 
setHead(int) - Method in class grph.algo.clustering.Cluster
 
setHeight(int) - Method in class grph.algo.topology.GridTopologyGenerator
 
setHeight(int) - Method in class grph.algo.topology.RandomizedGridTopology
 
setK(int) - Method in class grph.algo.topology.KClosestNeighborsTopologyGenerator
 
setK(int) - Method in class grph.algo.topology.RandomNewmanWattsStrogatzTopologyGenerator
 
setNEdgesPerStep(double) - Method in class grph.algo.topology.GLPIssamTopologyGenerator
 
setNInitialNodes(int) - Method in class grph.algo.topology.GLPIssamTopologyGenerator
number of nodes initially in the backbone before the beginning of the GLP generation
setNodePlacement(BriteTopologyGenerator.NODE_PLACEMENT) - Method in class grph.algo.topology.BriteTopologyGenerator
 
setNumberOfEdges(int) - Method in class grph.algo.topology.GNMTopologyGenerator
 
setNumberOfNeighboringNodesEachNewNodeConnects(int) - Method in class grph.algo.topology.BriteTopologyGenerator
 
setNumberOfSquaresInInnerPlanes(int) - Method in class grph.algo.topology.BriteTopologyGenerator
 
setNumberOfSquaresInTheMainPlane(int) - Method in class grph.algo.topology.BriteTopologyGenerator
 
setNumberOfStepsInAJump(int) - Method in class grph.stepper.AbstractStepper
 
setNumberOfStepsUntilNextWait(int) - Method in class grph.stepper.AbstractStepper
 
setObjective(LP, Grph) - Method in class grph.algo.covering_packing.LPBasedMaximumMatchingAlgorithm
 
setObjective(LP, Grph) - Method in class grph.algo.StructuredLPBasedAlgorithm
 
setOut(PrintStream) - Method in class grph.io.DynamicsLogger
 
setP(double) - Method in class grph.algo.topology.GLPIssamTopologyGenerator
 
setP(double) - Method in class grph.algo.topology.RandomNewmanWattsStrogatzTopologyGenerator
 
setPalette(ColorPalette) - Method in class grph.properties.NumericalProperty
 
setPlaneDimension(double) - Method in class grph.algo.topology.InetTopologyGenerator
 
setPrintEdges(boolean) - Method in class grph.io.EdgeListWriter
 
setPRNG(Random) - Method in class grph.algo.topology.GLPIssamTopologyGenerator
 
setPrng(Random) - Method in class grph.algo.topology.PlanarGraphTopologyGenerator
 
setPRNG(Random) - Method in class grph.algo.topology.RandomizedTopologyTransform
 
setProbability(double) - Method in class grph.algo.topology.GNPTopologyGenerator
 
setRandom(Random) - Method in class grph.algo.k_shortest_paths.RandomWalkBasedKShortestPaths
 
setS(int) - Method in class grph.algo.topology.rmat.RmatTopologyGenerator
 
setS2(int) - Method in class grph.algo.topology.rmat.RmatTopologyGenerator
 
setSource(int) - Method in class grph.path.ArrayListPath
 
setSource(int) - Method in class grph.path.ArrayPath
 
setSource(int) - Method in interface grph.path.Path
 
setSource(int) - Method in class grph.path.PathExtender
 
setSource(int) - Method in class grph.path.SearchResultWrappedPath
 
setSource(int) - Method in class grph.path.SingletonPath
 
setStatus(int, boolean) - Method in class grph.properties.Property
 
setValue(int, long) - Method in class grph.in_memory.SimpleEdgeIncidenceList
 
setValue(int, double) - Method in class grph.properties.NumericalProperty
 
setValue(int, float) - Method in class grph.properties.NumericalProperty
 
setValue(int, long) - Method in class grph.properties.NumericalProperty
 
setValue(int, String) - Method in class grph.properties.NumericalProperty
 
setValue(int, T) - Method in class grph.properties.ObjectProperty
 
setValue(int, String) - Method in class grph.properties.Property
 
setValue(int, String) - Method in class grph.properties.StringProperty
 
setValue(Object) - Method in class grph.report.Metric
 
setVerbose(boolean) - Method in class grph.stepper.AbstractStepper
 
setVertexLabel(V, String) - Method in class grph.oo.ObjectGrph
 
setVerticesColor(NumericalProperty) - Method in class grph.Grph
 
setVerticesLabel(Property) - Method in class grph.Grph
 
setVerticesShape(NumericalProperty) - Method in class grph.Grph
 
setVerticesSize(NumericalProperty) - Method in class grph.Grph
 
setWaxmanAlpha(double) - Method in class grph.algo.topology.BriteTopologyGenerator
 
setWaxmanBeta(double) - Method in class grph.algo.topology.BriteTopologyGenerator
 
setWidth(int) - Method in class grph.algo.topology.GridTopologyGenerator
 
setWidth(int) - Method in class grph.algo.topology.RandomizedGridTopology
 
ShapeProperty - Class in grph.properties
 
ShapeProperty(String) - Constructor for class grph.properties.ShapeProperty
 
ShellEditor - Class in grph.edit
 
ShellEditor(Grph) - Constructor for class grph.edit.ShellEditor
 
SHOW_LP - Static variable in class grph.algo.LPBasedAlgorithm
 
SHOW_SOL - Static variable in class grph.algo.LPBasedAlgorithm
 
SimpleCodes - Class in grph.demo
 
SimpleCodes() - Constructor for class grph.demo.SimpleCodes
 
SimpleEdgeIncidenceList - Class in grph.in_memory
 
SimpleEdgeIncidenceList() - Constructor for class grph.in_memory.SimpleEdgeIncidenceList
 
SimplenessAlgorithm - Class in grph.algo.structural
 
SimplenessAlgorithm() - Constructor for class grph.algo.structural.SimplenessAlgorithm
 
simplenessAlgorithm - Variable in class grph.Grph
 
SimplicialVertexFilter(Grph) - Constructor for class grph.ElementFilter.SimplicialVertexFilter
 
SingleSourceSearchAlgorithm<R extends SearchResult> - Class in grph.algo.search
 
SingleSourceSearchAlgorithm() - Constructor for class grph.algo.search.SingleSourceSearchAlgorithm
 
SingletonPath - Class in grph.path
 
SingletonPath(int) - Constructor for class grph.path.SingletonPath
 
sizeOf(T) - Method in class grph.properties.ObjectProperty
 
sizeOf(String) - Method in class grph.properties.StringProperty
 
SizeProperty - Class in grph.properties
 
SizeProperty(String) - Constructor for class grph.properties.SizeProperty
 
sort(Grph, IntSet) - Method in class grph.algo.sort.Sorter
 
Sorter - Class in grph.algo.sort
 
Sorter() - Constructor for class grph.algo.sort.Sorter
 
sortInPlace(Grph, int[]) - Method in class grph.algo.sort.Sorter
 
sortInPlace(Grph, int[], int, int) - Method in class grph.algo.sort.Sorter
 
sortTopologically() - Method in class grph.Grph
Topological sort of the vertices in this graph.
sortVerticesByDegree() - Method in class grph.Grph
Sort all vertices by degree.
SpanningTree - Class in grph.algo
 
SpanningTree() - Constructor for class grph.algo.SpanningTree
 
SpanningTreeAlgorithm - Interface in grph.algo
 
SparseCutAlgorithm - Class in grph.algo.sparse_cut
 
SparseCutAlgorithm() - Constructor for class grph.algo.sparse_cut.SparseCutAlgorithm
 
StackBasedBellmanFordAlgorithm - Class in grph.algo.search
BellmanFord using two stacks.
StackBasedBellmanFordAlgorithm(NumericalProperty) - Constructor for class grph.algo.search.StackBasedBellmanFordAlgorithm
 
StackBasedBellmanFordWeightedMatrixAlgorithm - Class in grph.algo.distance
 
StackBasedBellmanFordWeightedMatrixAlgorithm(NumericalProperty) - Constructor for class grph.algo.distance.StackBasedBellmanFordWeightedMatrixAlgorithm
 
start() - Method in class GrphApplet
 
StarTopologyGenerator - Class in grph.algo.topology
Connect nodes as a star, the user must provide the center and the edge factory.
StarTopologyGenerator() - Constructor for class grph.algo.topology.StarTopologyGenerator
 
stepMonitor() - Method in class grph.Grph
 
stop() - Method in class GrphApplet
 
storeEdges() - Method in interface grph.EdgeSet
 
storeEdges() - Method in class grph.in_memory.InMemoryGrph
Checks if the two given edges have the same vertices incident to them.
storeForAurelien(Report, Directory, Logger, PropertyFilenameCalculator) - Static method in class grph.report.Report
 
StringProperty - Class in grph.properties
 
StringProperty(String, int) - Constructor for class grph.properties.StringProperty
 
StronglyConnectedComponentsAlgorithm - Class in grph.algo
 
StronglyConnectedComponentsAlgorithm() - Constructor for class grph.algo.StronglyConnectedComponentsAlgorithm
 
StructuredLPBasedAlgorithm<R> - Class in grph.algo
 
StructuredLPBasedAlgorithm() - Constructor for class grph.algo.StructuredLPBasedAlgorithm
 
SubGraphIsomorphism4Julien - Class in grph.algo
 
SubGraphIsomorphism4Julien() - Constructor for class grph.algo.SubGraphIsomorphism4Julien
 
SubgraphSearch - Class in grph.algo.subgraph_isomorphism.own
 
SubgraphSearch() - Constructor for class grph.algo.subgraph_isomorphism.own.SubgraphSearch
 
Swing - Class in grph.gui
 
Swing() - Constructor for class grph.gui.Swing
 
SwingStepper - Class in grph.stepper
This is the equivalent of the StepAlgo class in Mascopt.
SwingStepper(Grph) - Constructor for class grph.stepper.SwingStepper
 
SwingStepper(Grph, boolean, boolean, boolean, boolean) - Constructor for class grph.stepper.SwingStepper
 

T

Tarjan - Class in grph.algo
 
Tarjan() - Constructor for class grph.algo.Tarjan
 
tarjan(Grph) - Static method in class grph.algo.Tarjan
 
tarjanSCC - Variable in class grph.Grph
 
test(int) - Method in class grph.ElementFilter.DegreeFilter
 
test(int) - Method in class grph.ElementFilter.LoopFilter
 
test(int) - Method in class grph.ElementFilter.SimplicialVertexFilter
 
Tests - Class in grph.in_memory
 
Tests() - Constructor for class grph.in_memory.Tests
 
Tet - Class in grph.stepper
 
Tet() - Constructor for class grph.stepper.Tet
 
theresAPath(int, int) - Method in class grph.algo.distance.DistanceMatrix
 
to(Map<String, Object>) - Method in class grph.io.DotWriter
 
toDot() - Method in class grph.Grph
Computes a GraphViz expression of this graph.
toEdgeList() - Method in class grph.Grph
 
toGraphML() - Method in class grph.Grph
Computes a GraphML (XML) expression of this graph.
toGraphStream_0_4_2_AWTComponent() - Method in class grph.Grph
 
toGraphviz(GraphvizImageWriter.COMMAND, GraphvizImageWriter.OUTPUT_FORMAT, Directory) - Method in class grph.Grph
Computes a graphic file containing a representation of this graph generated by GraphViz.
toGraphviz(GraphvizImageWriter.COMMAND, GraphvizImageWriter.OUTPUT_FORMAT) - Method in class grph.Grph
 
toGraphvizPNGAWTComponent() - Method in class grph.gui.GraphVizPNGGrphRenderer
 
toGrphBinary() - Method in class grph.Grph
Computes a native-Grph binary expression of this graph.
toGrphText() - Method in class grph.Grph
Computes a native-Grph textual expression of this graph.
topologicalSortingAlg - Variable in class grph.Grph
 
TopologicalSortingAlgorithm - Class in grph.algo
topological sort.
TopologicalSortingAlgorithm() - Constructor for class grph.algo.TopologicalSortingAlgorithm
 
TopologyGenerationException - Exception in grph.algo.topology
 
TopologyGenerationException(Exception) - Constructor for exception grph.algo.topology.TopologyGenerationException
 
TopologyGenerationException(String) - Constructor for exception grph.algo.topology.TopologyGenerationException
 
TopologyGenerator - Interface in grph.algo.topology
 
TopologyListener - Interface in grph
Objects that listen to graph topology changes need to implement this interface.
toString() - Method in class grph.algo.AdjacencyMatrix
 
toString() - Method in class grph.algo.clustering.Cluster
 
toString() - Method in class grph.algo.coloring.GraphColoring
Returns a string representation of a graph coloring.
toString() - Method in class grph.algo.MaxFlowAlgorithmResult
 
toString() - Method in class grph.algo.msp.EdgeProperty
 
toString(IntCollection) - Method in class grph.algo.search.SearchResult
 
toString() - Method in class grph.algo.structural.MultigraphnessResult
 
toString() - Method in class grph.dynamics.DynamicsEvent
 
toString(int) - Method in class grph.dynamics.DynamicsModel
 
toString() - Method in class grph.Grph
 
toString() - Method in exception grph.io.ParseException
 
toString() - Method in class grph.oo.ObjectPath
 
toString() - Method in class grph.path.AbstractPath
 
toString() - Method in class grph.path.PathExtender
 
toString() - Method in class grph.path.SingletonPath
 
toString(IntSet) - Method in class grph.properties.NumericalProperty
 
toString(InMemoryGrph, int) - Static method in class grph.properties.Property
 
toString() - Method in class grph.util.Matching
 
toString_elements() - Method in class grph.Grph
 
toTextADJ() - Method in class grph.Grph
 
toUndirectedGraph() - Method in class grph.Grph
 
toVertexArray() - Method in class grph.path.ArrayListPath
 
toVertexArray() - Method in class grph.path.ArrayPath
 
toVertexArray() - Method in interface grph.path.Path
Computes the sequence of vertices as an array of ints.
toVertexArray() - Method in class grph.path.PathExtender
 
toVertexArray() - Method in class grph.path.SearchResultWrappedPath
 
toVertexArray() - Method in class grph.path.SingletonPath
 
toVertexSet() - Method in class grph.path.AbstractPath
 
toVertexSet() - Method in interface grph.path.Path
 
TransitiveClosure - Class in grph.algo
 
TransitiveClosure() - Constructor for class grph.algo.TransitiveClosure
 
TreeBasedTraversal - Class in grph.algo.search
 
TreeBasedTraversal() - Constructor for class grph.algo.search.TreeBasedTraversal
 
TreenessAlgorithm - Class in grph.algo.structural
 
TreenessAlgorithm() - Constructor for class grph.algo.structural.TreenessAlgorithm
 
treenessAlgorithm - Variable in class grph.Grph
 
TreeOfRingsWirelessBackhaul - Class in grph.algo.topology.gsm
This topology generators creates a tree of rings.
TreeOfRingsWirelessBackhaul() - Constructor for class grph.algo.topology.gsm.TreeOfRingsWirelessBackhaul
 
trianglesAlgorithm - Variable in class grph.Grph
 
TwoSweepBFSDiameterApproximationAlgorithm - Class in grph.algo.distance
Computes the two-sweeps approximated diameter of the graph.
TwoSweepBFSDiameterApproximationAlgorithm() - Constructor for class grph.algo.distance.TwoSweepBFSDiameterApproximationAlgorithm
 
twoSweepDiameterAlg - Variable in class grph.Grph
 
TwoSweepsGraphCenter - Class in grph.algo.distance
 
TwoSweepsGraphCenter() - Constructor for class grph.algo.distance.TwoSweepsGraphCenter
 

U

UndirectedGraph - Interface in grph
 
undirectedHyperEdgeAdded(Grph, int) - Method in class grph.gui.GraphRenderer
 
undirectedHyperEdgeAdded(Grph, int) - Method in class grph.gui.GraphvizComponent
 
undirectedHyperEdgeAdded(Grph, int) - Method in interface grph.TopologyListener
 
undirectedHyperEdgeRemoved(Grph, int, IntSet) - Method in class grph.gui.GraphRenderer
 
undirectedHyperEdgeRemoved(Grph, int, IntSet) - Method in class grph.gui.GraphvizComponent
 
undirectedHyperEdgeRemoved(Grph, int, IntSet) - Method in interface grph.TopologyListener
 
UndirectedHyperGraph - Interface in grph
 
UndirectedLAD - Class in grph.algo.lad
LAD is a program (in C) for solving the subgraph isomorphism problem, the goal of which is to decide if there exists a copy of a pattern graph in a target graph.
UndirectedLAD() - Constructor for class grph.algo.lad.UndirectedLAD
 
undirectedSimpleEdgeAdded(Grph, int, int, int) - Method in class grph.gui.GraphRenderer
 
undirectedSimpleEdgeAdded(Grph, int, int, int) - Method in class grph.gui.GraphvizComponent
 
undirectedSimpleEdgeAdded(Grph, int, int, int) - Method in interface grph.TopologyListener
 
UndirectedSimpleEdgeAdditionMutation - Class in grph.topology.random.genetic
 
UndirectedSimpleEdgeAdditionMutation() - Constructor for class grph.topology.random.genetic.UndirectedSimpleEdgeAdditionMutation
 
undirectedSimpleEdgeRemoved(Grph, int, int, int) - Method in class grph.gui.GraphRenderer
 
undirectedSimpleEdgeRemoved(Grph, int, int, int) - Method in class grph.gui.GraphvizComponent
 
undirectedSimpleEdgeRemoved(Grph, int, int, int) - Method in interface grph.TopologyListener
 
UndirectedSimpleGraph - Interface in grph
 
undirectionalizeEdge(int) - Method in class grph.Grph
 
UnqualifiedGraph - Interface in grph
A graph with no information on the type of its edges
unsetItAll() - Method in class grph.properties.Property
 
unsetValue(int) - Method in class grph.in_memory.IncidenceList
 
UnweightedDistanceMatrixAlgorithm - Class in grph.algo.distance
 
UnweightedDistanceMatrixAlgorithm() - Constructor for class grph.algo.distance.UnweightedDistanceMatrixAlgorithm
 
unweightedDistanceMatrixAlgorithm - Variable in class grph.Grph
 
UnweightedPredecessorMatrixAlgorithm - Class in grph.algo.distance
 
UnweightedPredecessorMatrixAlgorithm() - Constructor for class grph.algo.distance.UnweightedPredecessorMatrixAlgorithm
 
unweightedPredecessorMatrixAlgorithm - Variable in class grph.Grph
 
update() - Method in class grph.gui.GraphRenderer
 
update() - Method in class grph.gui.GraphvizComponent
 
update() - Method in class grph.gui.GraphVizPNGGrphRenderer
 
useCache - Static variable in class grph.Grph
 

V

v1 - Variable in class grph.algo.structural.MultigraphnessResult
 
v2 - Variable in class grph.algo.structural.MultigraphnessResult
 
v2i(V) - Method in class grph.oo.ObjectGrph
 
v2i(Collection<V>) - Method in class grph.oo.ObjectGrph
 
valueChanged(Property, int) - Method in class grph.gui.GraphRenderer
 
valueChanged(Property, int) - Method in class grph.gui.GraphvizComponent
 
valueChanged(Property, int) - Method in interface grph.properties.PropertyListener
 
valueOf(String) - Static method in enum grph.algo.lad.LAD.MODE
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum grph.algo.partitionning.metis.Gpmetis.Ctype
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum grph.algo.partitionning.metis.Gpmetis.Iptype
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum grph.algo.partitionning.metis.Gpmetis.Objtype
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum grph.algo.partitionning.metis.Gpmetis.Ptype
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum grph.algo.search.GraphSearchListener.DECISION
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum grph.algo.topology.BriteTopologyGenerator.ALGO
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum grph.algo.topology.BriteTopologyGenerator.BWDist
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum grph.algo.topology.BriteTopologyGenerator.GrowthType
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum grph.algo.topology.BriteTopologyGenerator.NODE_PLACEMENT
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum grph.algo.triangles.latapi.MatthieuLatapyTriangleAlgorithm.ALGORITHM
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum grph.Grph.DIRECTION
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum grph.Grph.MaxIndependentSetAlgorithm
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum grph.Grph.MinVertexCoverAlgorithm
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum grph.Grph.TYPE
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum grph.io.GraphvizImageWriter.COMMAND
Returns the enum constant of this type with the specified name.
valueOf(String) - Static method in enum grph.io.GraphvizImageWriter.OUTPUT_FORMAT
Returns the enum constant of this type with the specified name.
values() - Static method in enum grph.algo.lad.LAD.MODE
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum grph.algo.partitionning.metis.Gpmetis.Ctype
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum grph.algo.partitionning.metis.Gpmetis.Iptype
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum grph.algo.partitionning.metis.Gpmetis.Objtype
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum grph.algo.partitionning.metis.Gpmetis.Ptype
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum grph.algo.search.GraphSearchListener.DECISION
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum grph.algo.topology.BriteTopologyGenerator.ALGO
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum grph.algo.topology.BriteTopologyGenerator.BWDist
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum grph.algo.topology.BriteTopologyGenerator.GrowthType
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum grph.algo.topology.BriteTopologyGenerator.NODE_PLACEMENT
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum grph.algo.triangles.latapi.MatthieuLatapyTriangleAlgorithm.ALGORITHM
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum grph.Grph.DIRECTION
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum grph.Grph.MaxIndependentSetAlgorithm
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum grph.Grph.MinVertexCoverAlgorithm
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum grph.Grph.TYPE
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum grph.io.GraphvizImageWriter.COMMAND
Returns an array containing the constants of this enum type, in the order they are declared.
values() - Static method in enum grph.io.GraphvizImageWriter.OUTPUT_FORMAT
Returns an array containing the constants of this enum type, in the order they are declared.
VEIterator - Interface in grph.algo
 
vertexAdded(Grph, int) - Method in class grph.gui.GraphRenderer
 
vertexAdded(Grph, int) - Method in class grph.gui.GraphvizComponent
 
vertexAdded(Grph, int) - Method in interface grph.TopologyListener
 
vertexAddedToDirectedHyperEdgeHead(Grph, int, int) - Method in class grph.gui.GraphRenderer
 
vertexAddedToDirectedHyperEdgeHead(Grph, int, int) - Method in class grph.gui.GraphvizComponent
 
vertexAddedToDirectedHyperEdgeHead(Grph, int, int) - Method in interface grph.TopologyListener
 
vertexAddedToDirectedHyperEdgeTail(Grph, int, int) - Method in class grph.gui.GraphRenderer
 
vertexAddedToDirectedHyperEdgeTail(Grph, int, int) - Method in class grph.gui.GraphvizComponent
 
vertexAddedToDirectedHyperEdgeTail(Grph, int, int) - Method in interface grph.TopologyListener
 
vertexAddedToUndirectedSimpleEdge(Grph, int, int) - Method in class grph.gui.GraphRenderer
 
vertexAddedToUndirectedSimpleEdge(Grph, int, int) - Method in class grph.gui.GraphvizComponent
 
vertexAddedToUndirectedSimpleEdge(Grph, int, int) - Method in interface grph.TopologyListener
 
VertexAdditionMutation - Class in grph.topology.random.genetic
 
VertexAdditionMutation() - Constructor for class grph.topology.random.genetic.VertexAdditionMutation
 
vertexAdjacenciesAsIDSetsAlgorithm - Variable in class grph.Grph
 
VertexAdjacencyAlgorithm - Class in grph.algo
Computes a list of adjacency lists.
VertexAdjacencyAlgorithm() - Constructor for class grph.algo.VertexAdjacencyAlgorithm
 
VertexAdjacencyAlgorithm.In - Class in grph.algo
 
VertexAdjacencyAlgorithm.InOut - Class in grph.algo
 
VertexAdjacencyAlgorithm.Out - Class in grph.algo
 
VertexAdjacencyListsAlgorithm - Class in grph.algo
Computes the vertex adjacency lists.
VertexAdjacencyListsAlgorithm() - Constructor for class grph.algo.VertexAdjacencyListsAlgorithm
 
VertexAlgorithm - Class in grph.algo
 
VertexAlgorithm() - Constructor for class grph.algo.VertexAlgorithm
 
vertexFound(int) - Method in interface grph.algo.search.GraphSearchListener
 
VertexLabelBasedSubgraphMatcher - Class in grph.algo.subgraph_isomorphism.own
 
VertexLabelBasedSubgraphMatcher() - Constructor for class grph.algo.subgraph_isomorphism.own.VertexLabelBasedSubgraphMatcher
 
VertexListAlgorithm - Class in grph.algo
Computes a list containing all vertices.
VertexListAlgorithm() - Constructor for class grph.algo.VertexListAlgorithm
 
vertexListAlgorithm - Variable in class grph.Grph
 
VertexPair - Class in grph
A pair of vertices.
VertexPair(int, int) - Constructor for class grph.VertexPair
 
VertexRemovalMutation - Class in grph.topology.random.genetic
 
VertexRemovalMutation() - Constructor for class grph.topology.random.genetic.VertexRemovalMutation
 
vertexRemoved(Grph, int) - Method in class grph.gui.GraphRenderer
 
vertexRemoved(Grph, int) - Method in class grph.gui.GraphvizComponent
 
vertexRemoved(Grph, int) - Method in interface grph.TopologyListener
 
vertexRemovedFromDirectedHyperEdgeHead(Grph, int, int) - Method in class grph.gui.GraphRenderer
 
vertexRemovedFromDirectedHyperEdgeHead(Grph, int, int) - Method in class grph.gui.GraphvizComponent
 
vertexRemovedFromDirectedHyperEdgeHead(Grph, int, int) - Method in interface grph.TopologyListener
 
vertexRemovedFromDirectedHyperEdgeTail(Grph, int, int) - Method in class grph.gui.GraphRenderer
 
vertexRemovedFromDirectedHyperEdgeTail(Grph, int, int) - Method in class grph.gui.GraphvizComponent
 
vertexRemovedFromDirectedHyperEdgeTail(Grph, int, int) - Method in interface grph.TopologyListener
 
vertexRemovedFromUndirectedHyperEdge(Grph, int, int) - Method in class grph.gui.GraphRenderer
 
vertexRemovedFromUndirectedHyperEdge(Grph, int, int) - Method in class grph.gui.GraphvizComponent
 
vertexRemovedFromUndirectedHyperEdge(Grph, int, int) - Method in interface grph.TopologyListener
 
VertexSet - Interface in grph
 
VertexSetAlgorithm - Class in grph.algo
Computes a list containing all vertices.
VertexSetAlgorithm() - Constructor for class grph.algo.VertexSetAlgorithm
 
visitOrder - Variable in class grph.algo.search.SearchResult
 

W

waitForUserInteraction() - Method in class grph.stepper.AbstractStepper
 
waitForUserInteraction() - Method in class grph.stepper.ConsoleStepper
 
waitForUserInteraction() - Method in class grph.stepper.SwingStepper
 
WeightedDistanceMatrixAlgorithm - Class in grph.algo.distance
 
WeightedDistanceMatrixAlgorithm(NumericalProperty) - Constructor for class grph.algo.distance.WeightedDistanceMatrixAlgorithm
 
WeightedPredecessorMatrixAlgorithm - Class in grph.algo.distance
 
WeightedPredecessorMatrixAlgorithm(NumericalProperty) - Constructor for class grph.algo.distance.WeightedPredecessorMatrixAlgorithm
 
WeightedSingleSourceSearchAlgorithm - Class in grph.algo.search
 
WeightedSingleSourceSearchAlgorithm(NumericalProperty) - Constructor for class grph.algo.search.WeightedSingleSourceSearchAlgorithm
 
whyNotApplicable(Grph) - Method in class grph.path.AbstractPath
 
whyNotApplicable(Grph) - Method in interface grph.path.Path
 
WirelessBackhaul - Class in grph.algo.topology.gsm
 
WirelessBackhaul(int, int, Random, double) - Constructor for class grph.algo.topology.gsm.WirelessBackhaul
 
writeGraph(Grph, OutputStream) - Method in class grph.io.AbstractGraphTextWriter
 
writeGraph(Grph, OutputStream) - Method in class grph.io.AbstractGraphWriter
 
writeGraph(Grph, RegularFile) - Method in class grph.io.AbstractGraphWriter
 
writeGraph(Grph) - Method in class grph.io.AbstractGraphWriter
 
writeGraph(Grph, OutputStream) - Method in class grph.io.ADJBinaryWriter
 
writeGraph(Grph, OutputStream) - Method in class grph.io.GraphvizImageWriter
Write SVG data to the stream.
writeGraph(Grph, GraphvizImageWriter.OUTPUT_FORMAT) - Method in class grph.io.GraphvizImageWriter
 
writeGraph(Grph, GraphvizImageWriter.COMMAND, GraphvizImageWriter.OUTPUT_FORMAT, boolean, OutputStream) - Method in class grph.io.GraphvizImageWriter
 
writeGraph(Grph, GraphvizImageWriter.COMMAND, GraphvizImageWriter.OUTPUT_FORMAT, boolean) - Method in class grph.io.GraphvizImageWriter
 
writeGraph(Grph, OutputStream) - Method in class grph.io.GrphBinaryWriter
 

Y

YenTopKShortestPathsAlgorithm - Class in grph.algo.k_shortest_paths
 
YenTopKShortestPathsAlgorithm() - Constructor for class grph.algo.k_shortest_paths.YenTopKShortestPathsAlgorithm
 
A B C D E F G H I K L M N O P R S T U V W Y 
Skip navigation links