123456789101112131415161718192021222324252627282930313233343536373839404142434445464748495051525354555657585960616263646566676869707172737475767778798081828384858687888990919293949596979899100101102103104105106107108109110111112113114115116117118119120121122123124125126127128129130131132133134135136137138139140141142143144145146147148149150151152153154155156157158159160161162163164165166167168169170171172173174175176177178179180181182183184185186187188189190191192193194195196197198199200201202203204205206207208209210211212213214215216217218219220221222223224225226227228229230231232233234235236237238239240241242243244245246247248249250251252253254255256257258259260261262263264265266267268269270271272273274275276277278279280281282283284285286287288289290291292293294295296297298299300301302303304305306307308309310311312313314315316317318319320321322323324325326327328329330331332333334335336337338339340341342343344345346347348349350351352353354355356357358359360361362363364365366367368369370371372373374375376377378379380381382383384385386387388389390391392393394395396397398399400401402403404405406407408409410411412413414415416417418419420421422423424425426427428429430431432433434435436437438439440441442443444445446447448449450451452453454455456457458459460461462463464465466467468469470471472473474475476477478479480481482483484485486487488489490491492493494495496497498499500501502503504505506507508509510511512513514515516517518519520521522523524525526527528529530531532533534535536537538539540541542543544545546547548549550551552553554555556557558559560561562563564565566567568569570571572573574575576577578579580581582583584585586587588589590591592593594595596597598599600601602603604605606607608609610611612613614615616617618619620621622623624625626627628629630631632633634635636637638639640641642643644645646647648649650651652653654655656657658659660661662663664665666667668669670671672673674675676677678679680681682683684685686687688689690691692693694695696697698699700701702703704705706707708709710711712713714715716717718719720721722723724725726727728729730731732733734735736737738739740741742743744745746747748749750751752753754755756757758759760761762763764765766767768769770771772773774775776777778779780781782783784785786787788789790791792793794795796797798799800801802803804805806807808809810811812813814815816817818819820821822823824825826827828829830831832833834835836837838839840841842843844845846847848849850851852853854855856857858859860861862863864865866867868869870871872873874875876877878879880881882883884885886887888889890891892893894895896897898899900901902903904905906907908909910911912913914915916917918919920921922923924925926927928929930931932933934935936937938939940941942943944945946947948949950951952953954955956957958959960961962963964965966967968969970971972973974975976977978979980981982983984985986987988989990991992993994995996997998999100010011002100310041005100610071008100910101011101210131014101510161017101810191020102110221023102410251026102710281029103010311032103310341035103610371038103910401041104210431044104510461047104810491050105110521053105410551056105710581059106010611062106310641065106610671068106910701071107210731074107510761077107810791080108110821083108410851086108710881089109010911092109310941095109610971098109911001101110211031104110511061107110811091110111111121113111411151116111711181119112011211122112311241125112611271128112911301131113211331134113511361137113811391140114111421143114411451146114711481149115011511152 |
- """
- ========================
- Cycle finding algorithms
- ========================
- """
- from collections import defaultdict
- from itertools import combinations, product
- import networkx as nx
- from networkx.utils import not_implemented_for, pairwise
- __all__ = [
- "cycle_basis",
- "simple_cycles",
- "recursive_simple_cycles",
- "find_cycle",
- "minimum_cycle_basis",
- "chordless_cycles",
- ]
- @not_implemented_for("directed")
- @not_implemented_for("multigraph")
- def cycle_basis(G, root=None):
- """Returns a list of cycles which form a basis for cycles of G.
- A basis for cycles of a network is a minimal collection of
- cycles such that any cycle in the network can be written
- as a sum of cycles in the basis. Here summation of cycles
- is defined as "exclusive or" of the edges. Cycle bases are
- useful, e.g. when deriving equations for electric circuits
- using Kirchhoff's Laws.
- Parameters
- ----------
- G : NetworkX Graph
- root : node, optional
- Specify starting node for basis.
- Returns
- -------
- A list of cycle lists. Each cycle list is a list of nodes
- which forms a cycle (loop) in G.
- Examples
- --------
- >>> G = nx.Graph()
- >>> nx.add_cycle(G, [0, 1, 2, 3])
- >>> nx.add_cycle(G, [0, 3, 4, 5])
- >>> print(nx.cycle_basis(G, 0))
- [[3, 4, 5, 0], [1, 2, 3, 0]]
- Notes
- -----
- This is adapted from algorithm CACM 491 [1]_.
- References
- ----------
- .. [1] Paton, K. An algorithm for finding a fundamental set of
- cycles of a graph. Comm. ACM 12, 9 (Sept 1969), 514-518.
- See Also
- --------
- simple_cycles
- """
- gnodes = set(G.nodes())
- cycles = []
- while gnodes: # loop over connected components
- if root is None:
- root = gnodes.pop()
- stack = [root]
- pred = {root: root}
- used = {root: set()}
- while stack: # walk the spanning tree finding cycles
- z = stack.pop() # use last-in so cycles easier to find
- zused = used[z]
- for nbr in G[z]:
- if nbr not in used: # new node
- pred[nbr] = z
- stack.append(nbr)
- used[nbr] = {z}
- elif nbr == z: # self loops
- cycles.append([z])
- elif nbr not in zused: # found a cycle
- pn = used[nbr]
- cycle = [nbr, z]
- p = pred[z]
- while p not in pn:
- cycle.append(p)
- p = pred[p]
- cycle.append(p)
- cycles.append(cycle)
- used[nbr].add(z)
- gnodes -= set(pred)
- root = None
- return cycles
- def simple_cycles(G, length_bound=None):
- """Find simple cycles (elementary circuits) of a graph.
- A `simple cycle`, or `elementary circuit`, is a closed path where
- no node appears twice. In a directed graph, two simple cycles are distinct
- if they are not cyclic permutations of each other. In an undirected graph,
- two simple cycles are distinct if they are not cyclic permutations of each
- other nor of the other's reversal.
- Optionally, the cycles are bounded in length. In the unbounded case, we use
- a nonrecursive, iterator/generator version of Johnson's algorithm [1]_. In
- the bounded case, we use a version of the algorithm of Gupta and
- Suzumura[2]_. There may be better algorithms for some cases [3]_ [4]_ [5]_.
- The algorithms of Johnson, and Gupta and Suzumura, are enhanced by some
- well-known preprocessing techniques. When G is directed, we restrict our
- attention to strongly connected components of G, generate all simple cycles
- containing a certain node, remove that node, and further decompose the
- remainder into strongly connected components. When G is undirected, we
- restrict our attention to biconnected components, generate all simple cycles
- containing a particular edge, remove that edge, and further decompose the
- remainder into biconnected components.
- Note that multigraphs are supported by this function -- and in undirected
- multigraphs, a pair of parallel edges is considered a cycle of length 2.
- Likewise, self-loops are considered to be cycles of length 1. We define
- cycles as sequences of nodes; so the presence of loops and parallel edges
- does not change the number of simple cycles in a graph.
- Parameters
- ----------
- G : NetworkX DiGraph
- A directed graph
- length_bound : int or None, optional (default=None)
- If length_bound is an int, generate all simple cycles of G with length at
- most length_bound. Otherwise, generate all simple cycles of G.
- Yields
- ------
- list of nodes
- Each cycle is represented by a list of nodes along the cycle.
- Examples
- --------
- >>> edges = [(0, 0), (0, 1), (0, 2), (1, 2), (2, 0), (2, 1), (2, 2)]
- >>> G = nx.DiGraph(edges)
- >>> sorted(nx.simple_cycles(G))
- [[0], [0, 1, 2], [0, 2], [1, 2], [2]]
- To filter the cycles so that they don't include certain nodes or edges,
- copy your graph and eliminate those nodes or edges before calling.
- For example, to exclude self-loops from the above example:
- >>> H = G.copy()
- >>> H.remove_edges_from(nx.selfloop_edges(G))
- >>> sorted(nx.simple_cycles(H))
- [[0, 1, 2], [0, 2], [1, 2]]
- Notes
- -----
- When length_bound is None, the time complexity is $O((n+e)(c+1))$ for $n$
- nodes, $e$ edges and $c$ simple circuits. Otherwise, when length_bound > 1,
- the time complexity is $O((c+n)(k-1)d^k)$ where $d$ is the average degree of
- the nodes of G and $k$ = length_bound.
- Raises
- ------
- ValueError
- when length_bound < 0.
- References
- ----------
- .. [1] Finding all the elementary circuits of a directed graph.
- D. B. Johnson, SIAM Journal on Computing 4, no. 1, 77-84, 1975.
- https://doi.org/10.1137/0204007
- .. [2] Finding All Bounded-Length Simple Cycles in a Directed Graph
- A. Gupta and T. Suzumura https://arxiv.org/abs/2105.10094
- .. [3] Enumerating the cycles of a digraph: a new preprocessing strategy.
- G. Loizou and P. Thanish, Information Sciences, v. 27, 163-182, 1982.
- .. [4] A search strategy for the elementary cycles of a directed graph.
- J.L. Szwarcfiter and P.E. Lauer, BIT NUMERICAL MATHEMATICS,
- v. 16, no. 2, 192-204, 1976.
- .. [5] Optimal Listing of Cycles and st-Paths in Undirected Graphs
- R. Ferreira and R. Grossi and A. Marino and N. Pisanti and R. Rizzi and
- G. Sacomoto https://arxiv.org/abs/1205.2766
- See Also
- --------
- cycle_basis
- chordless_cycles
- """
- if length_bound is not None:
- if length_bound == 0:
- return
- elif length_bound < 0:
- raise ValueError("length bound must be non-negative")
- directed = G.is_directed()
- yield from ([v] for v, Gv in G.adj.items() if v in Gv)
- if length_bound is not None and length_bound == 1:
- return
- if G.is_multigraph() and not directed:
- visited = set()
- for u, Gu in G.adj.items():
- multiplicity = ((v, len(Guv)) for v, Guv in Gu.items() if v in visited)
- yield from ([u, v] for v, m in multiplicity if m > 1)
- visited.add(u)
- # explicitly filter out loops; implicitly filter out parallel edges
- if directed:
- G = nx.DiGraph((u, v) for u, Gu in G.adj.items() for v in Gu if v != u)
- else:
- G = nx.Graph((u, v) for u, Gu in G.adj.items() for v in Gu if v != u)
- # this case is not strictly necessary but improves performance
- if length_bound is not None and length_bound == 2:
- if directed:
- visited = set()
- for u, Gu in G.adj.items():
- yield from (
- [v, u] for v in visited.intersection(Gu) if G.has_edge(v, u)
- )
- visited.add(u)
- return
- if directed:
- yield from _directed_cycle_search(G, length_bound)
- else:
- yield from _undirected_cycle_search(G, length_bound)
- def _directed_cycle_search(G, length_bound):
- """A dispatch function for `simple_cycles` for directed graphs.
- We generate all cycles of G through binary partition.
- 1. Pick a node v in G which belongs to at least one cycle
- a. Generate all cycles of G which contain the node v.
- b. Recursively generate all cycles of G \\ v.
- This is accomplished through the following:
- 1. Compute the strongly connected components SCC of G.
- 2. Select and remove a biconnected component C from BCC. Select a
- non-tree edge (u, v) of a depth-first search of G[C].
- 3. For each simple cycle P containing v in G[C], yield P.
- 4. Add the biconnected components of G[C \\ v] to BCC.
- If the parameter length_bound is not None, then step 3 will be limited to
- simple cycles of length at most length_bound.
- Parameters
- ----------
- G : NetworkX DiGraph
- A directed graph
- length_bound : int or None
- If length_bound is an int, generate all simple cycles of G with length at most length_bound.
- Otherwise, generate all simple cycles of G.
- Yields
- ------
- list of nodes
- Each cycle is represented by a list of nodes along the cycle.
- """
- scc = nx.strongly_connected_components
- components = [c for c in scc(G) if len(c) >= 2]
- while components:
- c = components.pop()
- Gc = G.subgraph(c)
- v = next(iter(c))
- if length_bound is None:
- yield from _johnson_cycle_search(Gc, [v])
- else:
- yield from _bounded_cycle_search(Gc, [v], length_bound)
- # delete v after searching G, to make sure we can find v
- G.remove_node(v)
- components.extend(c for c in scc(Gc) if len(c) >= 2)
- def _undirected_cycle_search(G, length_bound):
- """A dispatch function for `simple_cycles` for undirected graphs.
- We generate all cycles of G through binary partition.
- 1. Pick an edge (u, v) in G which belongs to at least one cycle
- a. Generate all cycles of G which contain the edge (u, v)
- b. Recursively generate all cycles of G \\ (u, v)
- This is accomplished through the following:
- 1. Compute the biconnected components BCC of G.
- 2. Select and remove a biconnected component C from BCC. Select a
- non-tree edge (u, v) of a depth-first search of G[C].
- 3. For each (v -> u) path P remaining in G[C] \\ (u, v), yield P.
- 4. Add the biconnected components of G[C] \\ (u, v) to BCC.
- If the parameter length_bound is not None, then step 3 will be limited to simple paths
- of length at most length_bound.
- Parameters
- ----------
- G : NetworkX Graph
- An undirected graph
- length_bound : int or None
- If length_bound is an int, generate all simple cycles of G with length at most length_bound.
- Otherwise, generate all simple cycles of G.
- Yields
- ------
- list of nodes
- Each cycle is represented by a list of nodes along the cycle.
- """
- bcc = nx.biconnected_components
- components = [c for c in bcc(G) if len(c) >= 3]
- while components:
- c = components.pop()
- Gc = G.subgraph(c)
- uv = list(next(iter(Gc.edges)))
- G.remove_edge(*uv)
- # delete (u, v) before searching G, to avoid fake 3-cycles [u, v, u]
- if length_bound is None:
- yield from _johnson_cycle_search(Gc, uv)
- else:
- yield from _bounded_cycle_search(Gc, uv, length_bound)
- components.extend(c for c in bcc(Gc) if len(c) >= 3)
- class _NeighborhoodCache(dict):
- """Very lightweight graph wrapper which caches neighborhoods as list.
- This dict subclass uses the __missing__ functionality to query graphs for
- their neighborhoods, and store the result as a list. This is used to avoid
- the performance penalty incurred by subgraph views.
- """
- def __init__(self, G):
- self.G = G
- def __missing__(self, v):
- Gv = self[v] = list(self.G[v])
- return Gv
- def _johnson_cycle_search(G, path):
- """The main loop of the cycle-enumeration algorithm of Johnson.
- Parameters
- ----------
- G : NetworkX Graph or DiGraph
- A graph
- path : list
- A cycle prefix. All cycles generated will begin with this prefix.
- Yields
- ------
- list of nodes
- Each cycle is represented by a list of nodes along the cycle.
- References
- ----------
- .. [1] Finding all the elementary circuits of a directed graph.
- D. B. Johnson, SIAM Journal on Computing 4, no. 1, 77-84, 1975.
- https://doi.org/10.1137/0204007
- """
- G = _NeighborhoodCache(G)
- blocked = set(path)
- B = defaultdict(set) # graph portions that yield no elementary circuit
- start = path[0]
- stack = [iter(G[path[-1]])]
- closed = [False]
- while stack:
- nbrs = stack[-1]
- for w in nbrs:
- if w == start:
- yield path[:]
- closed[-1] = True
- elif w not in blocked:
- path.append(w)
- closed.append(False)
- stack.append(iter(G[w]))
- blocked.add(w)
- break
- else: # no more nbrs
- stack.pop()
- v = path.pop()
- if closed.pop():
- if closed:
- closed[-1] = True
- unblock_stack = {v}
- while unblock_stack:
- u = unblock_stack.pop()
- if u in blocked:
- blocked.remove(u)
- unblock_stack.update(B[u])
- B[u].clear()
- else:
- for w in G[v]:
- B[w].add(v)
- def _bounded_cycle_search(G, path, length_bound):
- """The main loop of the cycle-enumeration algorithm of Gupta and Suzumura.
- Parameters
- ----------
- G : NetworkX Graph or DiGraph
- A graph
- path : list
- A cycle prefix. All cycles generated will begin with this prefix.
- length_bound: int
- A length bound. All cycles generated will have length at most length_bound.
- Yields
- ------
- list of nodes
- Each cycle is represented by a list of nodes along the cycle.
- References
- ----------
- .. [1] Finding All Bounded-Length Simple Cycles in a Directed Graph
- A. Gupta and T. Suzumura https://arxiv.org/abs/2105.10094
- """
- G = _NeighborhoodCache(G)
- lock = {v: 0 for v in path}
- B = defaultdict(set)
- start = path[0]
- stack = [iter(G[path[-1]])]
- blen = [length_bound]
- while stack:
- nbrs = stack[-1]
- for w in nbrs:
- if w == start:
- yield path[:]
- blen[-1] = 1
- elif len(path) < lock.get(w, length_bound):
- path.append(w)
- blen.append(length_bound)
- lock[w] = len(path)
- stack.append(iter(G[w]))
- break
- else:
- stack.pop()
- v = path.pop()
- bl = blen.pop()
- if blen:
- blen[-1] = min(blen[-1], bl)
- if bl < length_bound:
- relax_stack = [(bl, v)]
- while relax_stack:
- bl, u = relax_stack.pop()
- if lock.get(u, length_bound) < length_bound - bl + 1:
- lock[u] = length_bound - bl + 1
- relax_stack.extend((bl + 1, w) for w in B[u].difference(path))
- else:
- for w in G[v]:
- B[w].add(v)
- def chordless_cycles(G, length_bound=None):
- """Find simple chordless cycles of a graph.
- A `simple cycle` is a closed path where no node appears twice. In a simple
- cycle, a `chord` is an additional edge between two nodes in the cycle. A
- `chordless cycle` is a simple cycle without chords. Said differently, a
- chordless cycle is a cycle C in a graph G where the number of edges in the
- induced graph G[C] is equal to the length of `C`.
- Note that some care must be taken in the case that G is not a simple graph
- nor a simple digraph. Some authors limit the definition of chordless cycles
- to have a prescribed minimum length; we do not.
- 1. We interpret self-loops to be chordless cycles, except in multigraphs
- with multiple loops in parallel. Likewise, in a chordless cycle of
- length greater than 1, there can be no nodes with self-loops.
- 2. We interpret directed two-cycles to be chordless cycles, except in
- multi-digraphs when any edge in a two-cycle has a parallel copy.
- 3. We interpret parallel pairs of undirected edges as two-cycles, except
- when a third (or more) parallel edge exists between the two nodes.
- 4. Generalizing the above, edges with parallel clones may not occur in
- chordless cycles.
- In a directed graph, two chordless cycles are distinct if they are not
- cyclic permutations of each other. In an undirected graph, two chordless
- cycles are distinct if they are not cyclic permutations of each other nor of
- the other's reversal.
- Optionally, the cycles are bounded in length.
- We use an algorithm strongly inspired by that of Dias et al [1]_. It has
- been modified in the following ways:
- 1. Recursion is avoided, per Python's limitations
- 2. The labeling function is not necessary, because the starting paths
- are chosen (and deleted from the host graph) to prevent multiple
- occurrences of the same path
- 3. The search is optionally bounded at a specified length
- 4. Support for directed graphs is provided by extending cycles along
- forward edges, and blocking nodes along forward and reverse edges
- 5. Support for multigraphs is provided by omitting digons from the set
- of forward edges
- Parameters
- ----------
- G : NetworkX DiGraph
- A directed graph
- length_bound : int or None, optional (default=None)
- If length_bound is an int, generate all simple cycles of G with length at
- most length_bound. Otherwise, generate all simple cycles of G.
- Yields
- ------
- list of nodes
- Each cycle is represented by a list of nodes along the cycle.
- Examples
- --------
- >>> sorted(list(nx.chordless_cycles(nx.complete_graph(4))))
- [[1, 0, 2], [1, 0, 3], [2, 0, 3], [2, 1, 3]]
- Notes
- -----
- When length_bound is None, and the graph is simple, the time complexity is
- $O((n+e)(c+1))$ for $n$ nodes, $e$ edges and $c$ chordless cycles.
- Raises
- ------
- ValueError
- when length_bound < 0.
- References
- ----------
- .. [1] Efficient enumeration of chordless cycles
- E. Dias and D. Castonguay and H. Longo and W.A.R. Jradi
- https://arxiv.org/abs/1309.1051
- See Also
- --------
- simple_cycles
- """
- if length_bound is not None:
- if length_bound == 0:
- return
- elif length_bound < 0:
- raise ValueError("length bound must be non-negative")
- directed = G.is_directed()
- multigraph = G.is_multigraph()
- if multigraph:
- yield from ([v] for v, Gv in G.adj.items() if len(Gv.get(v, ())) == 1)
- else:
- yield from ([v] for v, Gv in G.adj.items() if v in Gv)
- if length_bound is not None and length_bound == 1:
- return
- # Nodes with loops cannot belong to longer cycles. Let's delete them here.
- # also, we implicitly reduce the multiplicity of edges down to 1 in the case
- # of multiedges.
- if directed:
- F = nx.DiGraph((u, v) for u, Gu in G.adj.items() if u not in Gu for v in Gu)
- B = F.to_undirected(as_view=False)
- else:
- F = nx.Graph((u, v) for u, Gu in G.adj.items() if u not in Gu for v in Gu)
- B = None
- # If we're given a multigraph, we have a few cases to consider with parallel
- # edges.
- #
- # 1. If we have 2 or more edges in parallel between the nodes (u, v), we
- # must not construct longer cycles along (u, v).
- # 2. If G is not directed, then a pair of parallel edges between (u, v) is a
- # chordless cycle unless there exists a third (or more) parallel edge.
- # 3. If G is directed, then parallel edges do not form cyles, but do
- # preclude back-edges from forming cycles (handled in the next section),
- # Thus, if an edge (u, v) is duplicated and the reverse (v, u) is also
- # present, then we remove both from F.
- #
- # In directed graphs, we need to consider both directions that edges can
- # take, so iterate over all edges (u, v) and possibly (v, u). In undirected
- # graphs, we need to be a little careful to only consider every edge once,
- # so we use a "visited" set to emulate node-order comparisons.
- if multigraph:
- if not directed:
- B = F.copy()
- visited = set()
- for u, Gu in G.adj.items():
- if directed:
- multiplicity = ((v, len(Guv)) for v, Guv in Gu.items())
- for v, m in multiplicity:
- if m > 1:
- F.remove_edges_from(((u, v), (v, u)))
- else:
- multiplicity = ((v, len(Guv)) for v, Guv in Gu.items() if v in visited)
- for v, m in multiplicity:
- if m == 2:
- yield [u, v]
- if m > 1:
- F.remove_edge(u, v)
- visited.add(u)
- # If we're given a directed graphs, we need to think about digons. If we
- # have two edges (u, v) and (v, u), then that's a two-cycle. If either edge
- # was duplicated above, then we removed both from F. So, any digons we find
- # here are chordless. After finding digons, we remove their edges from F
- # to avoid traversing them in the search for chordless cycles.
- if directed:
- for u, Fu in F.adj.items():
- digons = [[u, v] for v in Fu if F.has_edge(v, u)]
- yield from digons
- F.remove_edges_from(digons)
- F.remove_edges_from(e[::-1] for e in digons)
- if length_bound is not None and length_bound == 2:
- return
- # Now, we prepare to search for cycles. We have removed all cycles of
- # lengths 1 and 2, so F is a simple graph or simple digraph. We repeatedly
- # separate digraphs into their strongly connected components, and undirected
- # graphs into their biconnected components. For each component, we pick a
- # node v, search for chordless cycles based at each "stem" (u, v, w), and
- # then remove v from that component before separating the graph again.
- if directed:
- separate = nx.strongly_connected_components
- # Directed stems look like (u -> v -> w), so we use the product of
- # predecessors of v with successors of v.
- def stems(C, v):
- for u, w in product(C.pred[v], C.succ[v]):
- if not G.has_edge(u, w): # omit stems with acyclic chords
- yield [u, v, w], F.has_edge(w, u)
- else:
- separate = nx.biconnected_components
- # Undirected stems look like (u ~ v ~ w), but we must not also search
- # (w ~ v ~ u), so we use combinations of v's neighbors of length 2.
- def stems(C, v):
- yield from (([u, v, w], F.has_edge(w, u)) for u, w in combinations(C[v], 2))
- components = [c for c in separate(F) if len(c) > 2]
- while components:
- c = components.pop()
- v = next(iter(c))
- Fc = F.subgraph(c)
- Fcc = Bcc = None
- for S, is_triangle in stems(Fc, v):
- if is_triangle:
- yield S
- else:
- if Fcc is None:
- Fcc = _NeighborhoodCache(Fc)
- Bcc = Fcc if B is None else _NeighborhoodCache(B.subgraph(c))
- yield from _chordless_cycle_search(Fcc, Bcc, S, length_bound)
- components.extend(c for c in separate(F.subgraph(c - {v})) if len(c) > 2)
- def _chordless_cycle_search(F, B, path, length_bound):
- """The main loop for chordless cycle enumeration.
- This algorithm is strongly inspired by that of Dias et al [1]_. It has been
- modified in the following ways:
- 1. Recursion is avoided, per Python's limitations
- 2. The labeling function is not necessary, because the starting paths
- are chosen (and deleted from the host graph) to prevent multiple
- occurrences of the same path
- 3. The search is optionally bounded at a specified length
- 4. Support for directed graphs is provided by extending cycles along
- forward edges, and blocking nodes along forward and reverse edges
- 5. Support for multigraphs is provided by omitting digons from the set
- of forward edges
- Parameters
- ----------
- F : _NeighborhoodCache
- A graph of forward edges to follow in constructing cycles
- B : _NeighborhoodCache
- A graph of blocking edges to prevent the production of chordless cycles
- path : list
- A cycle prefix. All cycles generated will begin with this prefix.
- length_bound : int
- A length bound. All cycles generated will have length at most length_bound.
- Yields
- ------
- list of nodes
- Each cycle is represented by a list of nodes along the cycle.
- References
- ----------
- .. [1] Efficient enumeration of chordless cycles
- E. Dias and D. Castonguay and H. Longo and W.A.R. Jradi
- https://arxiv.org/abs/1309.1051
- """
- blocked = defaultdict(int)
- target = path[0]
- blocked[path[1]] = 1
- for w in path[1:]:
- for v in B[w]:
- blocked[v] += 1
- stack = [iter(F[path[2]])]
- while stack:
- nbrs = stack[-1]
- for w in nbrs:
- if blocked[w] == 1 and (length_bound is None or len(path) < length_bound):
- Fw = F[w]
- if target in Fw:
- yield path + [w]
- else:
- Bw = B[w]
- if target in Bw:
- continue
- for v in Bw:
- blocked[v] += 1
- path.append(w)
- stack.append(iter(Fw))
- break
- else:
- stack.pop()
- for v in B[path.pop()]:
- blocked[v] -= 1
- @not_implemented_for("undirected")
- def recursive_simple_cycles(G):
- """Find simple cycles (elementary circuits) of a directed graph.
- A `simple cycle`, or `elementary circuit`, is a closed path where
- no node appears twice. Two elementary circuits are distinct if they
- are not cyclic permutations of each other.
- This version uses a recursive algorithm to build a list of cycles.
- You should probably use the iterator version called simple_cycles().
- Warning: This recursive version uses lots of RAM!
- It appears in NetworkX for pedagogical value.
- Parameters
- ----------
- G : NetworkX DiGraph
- A directed graph
- Returns
- -------
- A list of cycles, where each cycle is represented by a list of nodes
- along the cycle.
- Example:
- >>> edges = [(0, 0), (0, 1), (0, 2), (1, 2), (2, 0), (2, 1), (2, 2)]
- >>> G = nx.DiGraph(edges)
- >>> nx.recursive_simple_cycles(G)
- [[0], [2], [0, 1, 2], [0, 2], [1, 2]]
- Notes
- -----
- The implementation follows pp. 79-80 in [1]_.
- The time complexity is $O((n+e)(c+1))$ for $n$ nodes, $e$ edges and $c$
- elementary circuits.
- References
- ----------
- .. [1] Finding all the elementary circuits of a directed graph.
- D. B. Johnson, SIAM Journal on Computing 4, no. 1, 77-84, 1975.
- https://doi.org/10.1137/0204007
- See Also
- --------
- simple_cycles, cycle_basis
- """
- # Jon Olav Vik, 2010-08-09
- def _unblock(thisnode):
- """Recursively unblock and remove nodes from B[thisnode]."""
- if blocked[thisnode]:
- blocked[thisnode] = False
- while B[thisnode]:
- _unblock(B[thisnode].pop())
- def circuit(thisnode, startnode, component):
- closed = False # set to True if elementary path is closed
- path.append(thisnode)
- blocked[thisnode] = True
- for nextnode in component[thisnode]: # direct successors of thisnode
- if nextnode == startnode:
- result.append(path[:])
- closed = True
- elif not blocked[nextnode]:
- if circuit(nextnode, startnode, component):
- closed = True
- if closed:
- _unblock(thisnode)
- else:
- for nextnode in component[thisnode]:
- if thisnode not in B[nextnode]: # TODO: use set for speedup?
- B[nextnode].append(thisnode)
- path.pop() # remove thisnode from path
- return closed
- path = [] # stack of nodes in current path
- blocked = defaultdict(bool) # vertex: blocked from search?
- B = defaultdict(list) # graph portions that yield no elementary circuit
- result = [] # list to accumulate the circuits found
- # Johnson's algorithm exclude self cycle edges like (v, v)
- # To be backward compatible, we record those cycles in advance
- # and then remove from subG
- for v in G:
- if G.has_edge(v, v):
- result.append([v])
- G.remove_edge(v, v)
- # Johnson's algorithm requires some ordering of the nodes.
- # They might not be sortable so we assign an arbitrary ordering.
- ordering = dict(zip(G, range(len(G))))
- for s in ordering:
- # Build the subgraph induced by s and following nodes in the ordering
- subgraph = G.subgraph(node for node in G if ordering[node] >= ordering[s])
- # Find the strongly connected component in the subgraph
- # that contains the least node according to the ordering
- strongcomp = nx.strongly_connected_components(subgraph)
- mincomp = min(strongcomp, key=lambda ns: min(ordering[n] for n in ns))
- component = G.subgraph(mincomp)
- if len(component) > 1:
- # smallest node in the component according to the ordering
- startnode = min(component, key=ordering.__getitem__)
- for node in component:
- blocked[node] = False
- B[node][:] = []
- dummy = circuit(startnode, startnode, component)
- return result
- def find_cycle(G, source=None, orientation=None):
- """Returns a cycle found via depth-first traversal.
- The cycle is a list of edges indicating the cyclic path.
- Orientation of directed edges is controlled by `orientation`.
- Parameters
- ----------
- G : graph
- A directed/undirected graph/multigraph.
- source : node, list of nodes
- The node from which the traversal begins. If None, then a source
- is chosen arbitrarily and repeatedly until all edges from each node in
- the graph are searched.
- orientation : None | 'original' | 'reverse' | 'ignore' (default: None)
- For directed graphs and directed multigraphs, edge traversals need not
- respect the original orientation of the edges.
- When set to 'reverse' every edge is traversed in the reverse direction.
- When set to 'ignore', every edge is treated as undirected.
- When set to 'original', every edge is treated as directed.
- In all three cases, the yielded edge tuples add a last entry to
- indicate the direction in which that edge was traversed.
- If orientation is None, the yielded edge has no direction indicated.
- The direction is respected, but not reported.
- Returns
- -------
- edges : directed edges
- A list of directed edges indicating the path taken for the loop.
- If no cycle is found, then an exception is raised.
- For graphs, an edge is of the form `(u, v)` where `u` and `v`
- are the tail and head of the edge as determined by the traversal.
- For multigraphs, an edge is of the form `(u, v, key)`, where `key` is
- the key of the edge. When the graph is directed, then `u` and `v`
- are always in the order of the actual directed edge.
- If orientation is not None then the edge tuple is extended to include
- the direction of traversal ('forward' or 'reverse') on that edge.
- Raises
- ------
- NetworkXNoCycle
- If no cycle was found.
- Examples
- --------
- In this example, we construct a DAG and find, in the first call, that there
- are no directed cycles, and so an exception is raised. In the second call,
- we ignore edge orientations and find that there is an undirected cycle.
- Note that the second call finds a directed cycle while effectively
- traversing an undirected graph, and so, we found an "undirected cycle".
- This means that this DAG structure does not form a directed tree (which
- is also known as a polytree).
- >>> G = nx.DiGraph([(0, 1), (0, 2), (1, 2)])
- >>> nx.find_cycle(G, orientation="original")
- Traceback (most recent call last):
- ...
- networkx.exception.NetworkXNoCycle: No cycle found.
- >>> list(nx.find_cycle(G, orientation="ignore"))
- [(0, 1, 'forward'), (1, 2, 'forward'), (0, 2, 'reverse')]
- See Also
- --------
- simple_cycles
- """
- if not G.is_directed() or orientation in (None, "original"):
- def tailhead(edge):
- return edge[:2]
- elif orientation == "reverse":
- def tailhead(edge):
- return edge[1], edge[0]
- elif orientation == "ignore":
- def tailhead(edge):
- if edge[-1] == "reverse":
- return edge[1], edge[0]
- return edge[:2]
- explored = set()
- cycle = []
- final_node = None
- for start_node in G.nbunch_iter(source):
- if start_node in explored:
- # No loop is possible.
- continue
- edges = []
- # All nodes seen in this iteration of edge_dfs
- seen = {start_node}
- # Nodes in active path.
- active_nodes = {start_node}
- previous_head = None
- for edge in nx.edge_dfs(G, start_node, orientation):
- # Determine if this edge is a continuation of the active path.
- tail, head = tailhead(edge)
- if head in explored:
- # Then we've already explored it. No loop is possible.
- continue
- if previous_head is not None and tail != previous_head:
- # This edge results from backtracking.
- # Pop until we get a node whose head equals the current tail.
- # So for example, we might have:
- # (0, 1), (1, 2), (2, 3), (1, 4)
- # which must become:
- # (0, 1), (1, 4)
- while True:
- try:
- popped_edge = edges.pop()
- except IndexError:
- edges = []
- active_nodes = {tail}
- break
- else:
- popped_head = tailhead(popped_edge)[1]
- active_nodes.remove(popped_head)
- if edges:
- last_head = tailhead(edges[-1])[1]
- if tail == last_head:
- break
- edges.append(edge)
- if head in active_nodes:
- # We have a loop!
- cycle.extend(edges)
- final_node = head
- break
- else:
- seen.add(head)
- active_nodes.add(head)
- previous_head = head
- if cycle:
- break
- else:
- explored.update(seen)
- else:
- assert len(cycle) == 0
- raise nx.exception.NetworkXNoCycle("No cycle found.")
- # We now have a list of edges which ends on a cycle.
- # So we need to remove from the beginning edges that are not relevant.
- for i, edge in enumerate(cycle):
- tail, head = tailhead(edge)
- if tail == final_node:
- break
- return cycle[i:]
- @not_implemented_for("directed")
- @not_implemented_for("multigraph")
- def minimum_cycle_basis(G, weight=None):
- """Returns a minimum weight cycle basis for G
- Minimum weight means a cycle basis for which the total weight
- (length for unweighted graphs) of all the cycles is minimum.
- Parameters
- ----------
- G : NetworkX Graph
- weight: string
- name of the edge attribute to use for edge weights
- Returns
- -------
- A list of cycle lists. Each cycle list is a list of nodes
- which forms a cycle (loop) in G. Note that the nodes are not
- necessarily returned in a order by which they appear in the cycle
- Examples
- --------
- >>> G = nx.Graph()
- >>> nx.add_cycle(G, [0, 1, 2, 3])
- >>> nx.add_cycle(G, [0, 3, 4, 5])
- >>> print([sorted(c) for c in nx.minimum_cycle_basis(G)])
- [[0, 1, 2, 3], [0, 3, 4, 5]]
- References:
- [1] Kavitha, Telikepalli, et al. "An O(m^2n) Algorithm for
- Minimum Cycle Basis of Graphs."
- http://link.springer.com/article/10.1007/s00453-007-9064-z
- [2] de Pina, J. 1995. Applications of shortest path methods.
- Ph.D. thesis, University of Amsterdam, Netherlands
- See Also
- --------
- simple_cycles, cycle_basis
- """
- # We first split the graph in connected subgraphs
- return sum(
- (_min_cycle_basis(G.subgraph(c), weight) for c in nx.connected_components(G)),
- [],
- )
- def _min_cycle_basis(comp, weight):
- cb = []
- # We extract the edges not in a spanning tree. We do not really need a
- # *minimum* spanning tree. That is why we call the next function with
- # weight=None. Depending on implementation, it may be faster as well
- spanning_tree_edges = list(nx.minimum_spanning_edges(comp, weight=None, data=False))
- edges_excl = [frozenset(e) for e in comp.edges() if e not in spanning_tree_edges]
- N = len(edges_excl)
- # We maintain a set of vectors orthogonal to sofar found cycles
- set_orth = [{edge} for edge in edges_excl]
- for k in range(N):
- # kth cycle is "parallel" to kth vector in set_orth
- new_cycle = _min_cycle(comp, set_orth[k], weight=weight)
- cb.append(list(set().union(*new_cycle)))
- # now update set_orth so that k+1,k+2... th elements are
- # orthogonal to the newly found cycle, as per [p. 336, 1]
- base = set_orth[k]
- set_orth[k + 1 :] = [
- orth ^ base if len(orth & new_cycle) % 2 else orth
- for orth in set_orth[k + 1 :]
- ]
- return cb
- def _min_cycle(G, orth, weight=None):
- """
- Computes the minimum weight cycle in G,
- orthogonal to the vector orth as per [p. 338, 1]
- """
- T = nx.Graph()
- nodes_idx = {node: idx for idx, node in enumerate(G.nodes())}
- idx_nodes = {idx: node for node, idx in nodes_idx.items()}
- nnodes = len(nodes_idx)
- # Add 2 copies of each edge in G to T. If edge is in orth, add cross edge;
- # otherwise in-plane edge
- for u, v, data in G.edges(data=True):
- uidx, vidx = nodes_idx[u], nodes_idx[v]
- edge_w = data.get(weight, 1)
- if frozenset((u, v)) in orth:
- T.add_edges_from(
- [(uidx, nnodes + vidx), (nnodes + uidx, vidx)], weight=edge_w
- )
- else:
- T.add_edges_from(
- [(uidx, vidx), (nnodes + uidx, nnodes + vidx)], weight=edge_w
- )
- all_shortest_pathlens = dict(nx.shortest_path_length(T, weight=weight))
- cross_paths_w_lens = {
- n: all_shortest_pathlens[n][nnodes + n] for n in range(nnodes)
- }
- # Now compute shortest paths in T, which translates to cyles in G
- start = min(cross_paths_w_lens, key=cross_paths_w_lens.get)
- end = nnodes + start
- min_path = nx.shortest_path(T, source=start, target=end, weight="weight")
- # Now we obtain the actual path, re-map nodes in T to those in G
- min_path_nodes = [node if node < nnodes else node - nnodes for node in min_path]
- # Now remove the edges that occur two times
- mcycle_pruned = _path_to_cycle(min_path_nodes)
- return {frozenset((idx_nodes[u], idx_nodes[v])) for u, v in mcycle_pruned}
- def _path_to_cycle(path):
- """
- Removes the edges from path that occur even number of times.
- Returns a set of edges
- """
- edges = set()
- for edge in pairwise(path):
- # Toggle whether to keep the current edge.
- edges ^= {edge}
- return edges
|