Last active
December 12, 2023 14:11
-
-
Save eriknw/6017eec12e3dc61fbfba191144b0ae6b to your computer and use it in GitHub Desktop.
NetworkX dependencies between dispatched functions
This file contains hidden or bidirectional Unicode text that may be interpreted or compiled differently than what appears below. To review, open the file in an editor that reveals hidden Unicode characters.
Learn more about bidirectional Unicode characters
| digraph { | |
| all_pairs_shortest_path_length; | |
| boruvka_mst_edges; | |
| greedy_k_edge_augmentation; | |
| minimum_cut_value; | |
| immediate_dominators; | |
| closeness_centrality; | |
| dag_longest_path; | |
| condensation; | |
| maximum_flow_value; | |
| average_node_connectivity; | |
| relaxed_caveman_graph; | |
| current_flow_betweenness_centrality; | |
| eccentricity; | |
| traveling_salesman_problem; | |
| constraint; | |
| local_bridges; | |
| group_in_degree_centrality; | |
| minimum_cycle_basis; | |
| girvan_newman; | |
| shortest_path_length; | |
| minimum_node_cut; | |
| disjoint_union_all; | |
| visibility_graph; | |
| held_karp_ascent; | |
| local_efficiency; | |
| newman_betweenness_centrality; | |
| ramsey_R2; | |
| local_node_connectivity; | |
| frucht_graph; | |
| topological_generations; | |
| christofides; | |
| wiener_index; | |
| effective_size; | |
| lattice_reference; | |
| parse_gml; | |
| all_pairs_node_connectivity; | |
| agraph_read_dot; | |
| join_trees; | |
| attracting_components; | |
| sets; | |
| to_scipy_sparse_array; | |
| directed_combinatorial_laplacian_matrix; | |
| node_connectivity; | |
| hamiltonian_path; | |
| minimum_edge_cut; | |
| minimum_st_node_cut; | |
| all_pairs_dijkstra; | |
| partial_k_edge_augmentation; | |
| all_node_cuts; | |
| get_counterexample_recursive; | |
| simple_cycles; | |
| spectral_ordering; | |
| floyd_warshall_numpy; | |
| read_gml; | |
| global_efficiency; | |
| single_source_bellman_ford; | |
| is_semiconnected; | |
| havel_hakimi_graph; | |
| tournament_is_strongly_connected; | |
| normalized_mutual_weight; | |
| optimize_edit_paths; | |
| eulerize; | |
| is_eulerian; | |
| periphery; | |
| edge_connectivity; | |
| strategy_connected_sequential_bfs; | |
| k_corona; | |
| bfs_predecessors; | |
| hits; | |
| all_pairs_dijkstra_path_length; | |
| is_locally_k_edge_connected; | |
| ancestors; | |
| kosaraju_strongly_connected_components; | |
| inverse_line_graph; | |
| random_reference; | |
| prim_mst_edges; | |
| k_edge_components; | |
| color; | |
| shortest_path; | |
| reverse; | |
| omega; | |
| k_edge_augmentation; | |
| root_to_leaf_paths; | |
| all_pairs_shortest_path; | |
| is_reachable; | |
| transitive_closure_dag; | |
| transitive_closure; | |
| min_edge_dominating_set; | |
| approximate_diameter; | |
| edge_disjoint_paths; | |
| bridges; | |
| greedy_color; | |
| volume; | |
| girth; | |
| k_crust; | |
| compose; | |
| from_pandas_adjacency; | |
| read_weighted_edgelist; | |
| chordless_cycles; | |
| k_components; | |
| min_cost_flow; | |
| find_asteroidal_triple; | |
| edge_boundary; | |
| second_order_centrality; | |
| tutte_polynomial; | |
| adjacency_matrix; | |
| vf2pp_all_isomorphisms; | |
| barycenter; | |
| contracted_edge; | |
| triangular_lattice_graph; | |
| clique_removal; | |
| generic_bfs_edges; | |
| number_of_walks; | |
| quotient_graph; | |
| diameter; | |
| sudoku_graph; | |
| connected_watts_strogatz_graph; | |
| all_triads; | |
| k_core; | |
| random_tree; | |
| read_graphml; | |
| dag_longest_path_length; | |
| mutual_weight; | |
| junction_tree; | |
| chain_decomposition; | |
| scale_free_graph; | |
| from_pandas_edgelist; | |
| current_flow_betweenness_centrality_subset; | |
| get_counterexample; | |
| find_induced_nodes; | |
| modularity_matrix; | |
| strategy_smallest_last; | |
| eigenvector_centrality_numpy; | |
| minimum_branching; | |
| bipartite_parse_edgelist; | |
| connected_double_edge_swap; | |
| chromatic_polynomial; | |
| algebraic_connectivity; | |
| all_pairs_dijkstra_path; | |
| strategy_saturation_largest_first; | |
| minimal_d_separator; | |
| general_random_intersection_graph; | |
| spectral_graph_forge; | |
| intersection_all; | |
| make_max_clique_graph; | |
| random_tournament; | |
| complete_to_chordal_graph; | |
| trophic_differences; | |
| from_dict_of_dicts; | |
| is_minimal_d_separator; | |
| has_eulerian_path; | |
| reciprocity; | |
| non_randomness; | |
| has_path; | |
| biconnected_components; | |
| waxman_graph; | |
| mycielskian; | |
| effective_graph_resistance; | |
| has_bridges; | |
| harmonic_centrality; | |
| kemeny_constant; | |
| read_p2g; | |
| degree_sequence_tree; | |
| random_unlabeled_tree; | |
| optimize_graph_edit_distance; | |
| average_shortest_path_length; | |
| resistance_distance; | |
| k_truss; | |
| grid_graph; | |
| gnmk_random_graph; | |
| minimum_st_edge_cut; | |
| uniform_random_intersection_graph; | |
| union_all; | |
| find_creation_sequence; | |
| directed_havel_hakimi_graph; | |
| bipartite_closeness_centrality; | |
| intersection_array; | |
| normalized_laplacian_matrix; | |
| node_degree_xy; | |
| negative_edge_cycle; | |
| closeness_vitality; | |
| shortest_augmenting_path; | |
| degree_assortativity_coefficient; | |
| hkn_harary_graph; | |
| descendants_at_distance; | |
| lukes_partitioning; | |
| weighted_bridge_augmentation; | |
| normalized_cut_size; | |
| pagerank; | |
| minimum_weight_full_matching; | |
| katz_centrality_numpy; | |
| astar_path_length; | |
| attribute_mixing_dict; | |
| random_spanning_tree; | |
| from_nested_tuple; | |
| sedgewick_maze_graph; | |
| strongly_connected_components_recursive; | |
| approximate_all_pairs_node_connectivity; | |
| parse_edgelist; | |
| center; | |
| tree_all_pairs_lowest_common_ancestor; | |
| minimum_cut; | |
| relabel_nodes; | |
| conductance; | |
| all_pairs_lowest_common_ancestor; | |
| random_unlabeled_rooted_forest; | |
| metric_closure; | |
| check_planarity; | |
| louvain_communities; | |
| all_pairs_bellman_ford_path_length; | |
| incremental_closeness_centrality; | |
| naive_greedy_modularity_communities; | |
| k_random_intersection_graph; | |
| local_reaching_centrality; | |
| complete_multipartite_graph; | |
| bethe_hessian_spectrum; | |
| isolates; | |
| is_valid_degree_sequence_erdos_gallai; | |
| bfs_successors; | |
| strategy_independent_set; | |
| minimum_spanning_edges; | |
| mycielski_graph; | |
| is_at_free; | |
| barabasi_albert_graph; | |
| make_clique_bipartite; | |
| tetrahedral_graph; | |
| random_k_out_graph; | |
| is_tree; | |
| soft_random_geometric_graph; | |
| random_lobster; | |
| predecessor; | |
| overall_reciprocity; | |
| is_strongly_connected; | |
| dag_to_branching; | |
| modularity_spectrum; | |
| LCF_graph; | |
| root_trees; | |
| caveman_graph; | |
| is_graphical; | |
| antichains; | |
| gomory_hu_tree; | |
| general_k_edge_subgraphs; | |
| random_regular_graph; | |
| attribute_assortativity_coefficient; | |
| approximate_node_connectivity; | |
| read_graph6; | |
| balanced_tree; | |
| all_shortest_paths; | |
| dual_barabasi_albert_graph; | |
| is_k_edge_connected; | |
| bfs_beam_edges; | |
| radius; | |
| harmonic_function; | |
| create_component_structure; | |
| approximate_current_flow_betweenness_centrality; | |
| read_leda; | |
| binomial_tree; | |
| chordal_graph_treewidth; | |
| extended_barabasi_albert_graph; | |
| approximate_k_components; | |
| panther_similarity; | |
| all_simple_edge_paths; | |
| laplacian_centrality; | |
| communicability; | |
| dominance_frontiers; | |
| trivial_graph; | |
| is_kl_connected; | |
| configuration_model; | |
| node_clique_number; | |
| label_propagation_communities; | |
| tree_isomorphism; | |
| equitable_color; | |
| recursive_simple_cycles; | |
| pydot_read_dot; | |
| from_scipy_sparse_array; | |
| k_shell; | |
| local_constraint; | |
| maximum_branching; | |
| random_unlabeled_rooted_tree; | |
| current_flow_closeness_centrality; | |
| complement_edges; | |
| turan_graph; | |
| complement; | |
| capacity_scaling; | |
| from_dict_of_lists; | |
| greedy_tsp; | |
| bellman_ford_predecessor_and_distance; | |
| global_reaching_centrality; | |
| spectral_bisection; | |
| maximum_flow; | |
| ladder_graph; | |
| triads_by_type; | |
| single_source_dijkstra_path; | |
| all_pairs_all_shortest_paths; | |
| steiner_tree; | |
| gnc_graph; | |
| single_source_all_shortest_paths; | |
| pappus_graph; | |
| margulis_gabber_galil_graph; | |
| one_exchange; | |
| estrada_index; | |
| is_biconnected; | |
| cycle_graph; | |
| fast_gnp_random_graph; | |
| edge_load_centrality; | |
| asyn_fluidc; | |
| is_partition; | |
| maximum_spanning_tree; | |
| unconstrained_one_edge_augmentation; | |
| adjacency_spectrum; | |
| parse_leda; | |
| hoffman_singleton_graph; | |
| bridge_augmentation; | |
| edge_betweenness_centrality; | |
| directed_modularity_matrix; | |
| directed_laplacian_matrix; | |
| number_weakly_connected_components; | |
| parse_adjlist; | |
| connected_caveman_graph; | |
| is_chordal; | |
| clustering; | |
| boykov_kolmogorov; | |
| convert_node_labels_to_integers; | |
| dfs_edges; | |
| threshold_graph; | |
| read_edgelist; | |
| bethe_hessian_matrix; | |
| node_disjoint_paths; | |
| modularity; | |
| is_directed_acyclic_graph; | |
| edge_bfs; | |
| vf2pp_is_isomorphic; | |
| is_perfect_matching; | |
| geographical_threshold_graph; | |
| find_cycle; | |
| sigma; | |
| edmonds_karp_core; | |
| is_valid_directed_joint_degree; | |
| newman_watts_strogatz_graph; | |
| strategy_random_sequential; | |
| local_edge_connectivity; | |
| has_cycle; | |
| is_aperiodic; | |
| dijkstra_path_length; | |
| preflow_push; | |
| group_out_degree_centrality; | |
| read_gexf; | |
| prominent_group; | |
| threshold_accepting_tsp; | |
| hexagonal_lattice_graph; | |
| eulerian_circuit; | |
| empty_graph; | |
| all_simple_paths; | |
| is_bipartite_node_set; | |
| find_threshold_graph; | |
| optimal_edit_paths; | |
| random_powerlaw_tree_sequence; | |
| flow_hierarchy; | |
| gnr_graph; | |
| dfs_successors; | |
| union; | |
| stochastic_graph; | |
| simulated_annealing_tsp; | |
| bellman_ford_path_length; | |
| edge_expansion; | |
| dodecahedral_graph; | |
| laplacian_matrix; | |
| house_x_graph; | |
| min_edge_cover; | |
| truncated_tetrahedron_graph; | |
| kruskal_mst_edges; | |
| bull_graph; | |
| ego_graph; | |
| build_auxiliary_edge_connectivity; | |
| k_clique_communities; | |
| is_branching; | |
| gnm_random_graph; | |
| k_factor; | |
| eulerian_path; | |
| chordal_cycle_graph; | |
| normalized_laplacian_spectrum; | |
| weighted_one_edge_augmentation; | |
| thresholded_random_geometric_graph; | |
| random_labeled_tree; | |
| bipartite_havel_hakimi_graph; | |
| paley_graph; | |
| complete_graph; | |
| heawood_graph; | |
| is_valid_degree_sequence_havel_hakimi; | |
| asadpour_atsp; | |
| k_edge_subgraphs; | |
| parse_graphml; | |
| is_semieulerian; | |
| strategy_largest_first; | |
| from_edgelist; | |
| directed_configuration_model; | |
| joint_degree_graph; | |
| disjoint_union; | |
| floyd_warshall; | |
| bipartite_read_edgelist; | |
| numeric_assortativity_coefficient; | |
| complete_bipartite_graph; | |
| dfs_preorder_nodes; | |
| is_arborescence; | |
| degree_mixing_dict; | |
| to_prufer_sequence; | |
| collapse; | |
| gaussian_random_partition_graph; | |
| check_planarity_recursive; | |
| is_weakly_connected; | |
| latapy_clustering; | |
| pad_graph; | |
| kernighan_lin_bisection; | |
| bfs_layers; | |
| bfs_edges; | |
| random_geometric_graph; | |
| full_join; | |
| dense_gnm_random_graph; | |
| is_strongly_regular; | |
| multi_source_dijkstra_path_length; | |
| line_graph; | |
| read_sparse6; | |
| google_matrix; | |
| maximum_spanning_edges; | |
| grid_2d_graph; | |
| reverse_havel_hakimi_graph; | |
| unconstrained_bridge_augmentation; | |
| house_graph; | |
| gn_graph; | |
| read_pajek; | |
| diamond_graph; | |
| spectral_bipartivity; | |
| communicability_betweenness_centrality; | |
| read_multiline_adjlist; | |
| treewidth_min_degree; | |
| parse_multiline_adjlist; | |
| is_forest; | |
| windmill_graph; | |
| single_source_dijkstra_path_length; | |
| build_auxiliary_node_connectivity; | |
| rich_club_coefficient; | |
| kl_connected_subgraph; | |
| tadpole_graph; | |
| min_cost_flow_cost; | |
| intersection; | |
| moebius_kantor_graph; | |
| dinitz; | |
| tutte_graph; | |
| network_simplex; | |
| dfs_labeled_edges; | |
| lollipop_graph; | |
| louvain_partitions; | |
| maximum_spanning_arborescence; | |
| triad_type; | |
| number_attracting_components; | |
| strategy_connected_sequential; | |
| lowest_common_ancestor; | |
| biadjacency_matrix; | |
| group_betweenness_centrality; | |
| tournament_matrix; | |
| bidirectional_shortest_path; | |
| to_nested_tuple; | |
| multi_source_dijkstra; | |
| spanning_tree_distribution; | |
| bipartite_min_edge_cover; | |
| hypercube_graph; | |
| is_connected; | |
| truncated_cube_graph; | |
| strongly_connected_components; | |
| is_coloring; | |
| is_valid_joint_degree; | |
| cut_size; | |
| projected_graph; | |
| star_graph; | |
| gnp_random_graph; | |
| minimum_spanning_tree; | |
| spanner; | |
| bipartite_configuration_model; | |
| to_numpy_array; | |
| icosahedral_graph; | |
| circular_ladder_graph; | |
| edge_current_flow_betweenness_centrality; | |
| min_weight_matching; | |
| from_prufer_sequence; | |
| krackhardt_kite_graph; | |
| degree_mixing_matrix; | |
| stoer_wagner; | |
| laplacian_spectrum; | |
| hnm_harary_graph; | |
| number_strongly_connected_components; | |
| from_agraph; | |
| dijkstra_predecessor_and_distance; | |
| multi_source_dijkstra_path; | |
| null_graph; | |
| could_be_isomorphic; | |
| random_degree_sequence_graph; | |
| maximum_independent_set; | |
| number_of_nonisomorphic_trees; | |
| astar_path; | |
| bfs_tree; | |
| node_boundary; | |
| node_connected_component; | |
| number_connected_components; | |
| max_clique; | |
| full_rary_tree; | |
| circulant_graph; | |
| cubical_graph; | |
| betweenness_centrality; | |
| random_labeled_rooted_tree; | |
| fast_could_be_isomorphic; | |
| parse_p2g; | |
| total_spanning_tree_weight; | |
| bellman_ford_path; | |
| random_clustered_graph; | |
| common_neighbor_centrality; | |
| efficiency; | |
| path_graph; | |
| floyd_warshall_predecessor_and_distance; | |
| from_pydot; | |
| d_separated; | |
| rooted_tree_isomorphism; | |
| assign_levels; | |
| dfs_postorder_nodes; | |
| single_source_shortest_path_length; | |
| random_partition_graph; | |
| build_residual_network; | |
| flow_matrix_row; | |
| partition_spanning_tree; | |
| single_source_shortest_path; | |
| triangles; | |
| edge_dfs; | |
| inter_community_edges; | |
| degree_pearson_correlation_coefficient; | |
| dorogovtsev_goltsev_mendes_graph; | |
| alternating_havel_hakimi_graph; | |
| dfs_tree; | |
| edmonds_karp; | |
| watts_strogatz_graph; | |
| minimum_spanning_arborescence; | |
| min_maximal_matching; | |
| onion_layers; | |
| transitivity; | |
| bfs_labeled_edges; | |
| stochastic_block_model; | |
| mixing_expansion; | |
| is_planar; | |
| maximal_matching; | |
| desargues_graph; | |
| local_and_global_consistency; | |
| max_weight_matching; | |
| hopcroft_karp_matching; | |
| bidirectional_dijkstra; | |
| from_sparse6_bytes; | |
| trophic_levels; | |
| eppstein_matching; | |
| directed_joint_degree_graph; | |
| to_vertex_cover; | |
| partial_duplication_graph; | |
| one_edge_augmentation; | |
| transitive_reduction; | |
| max_flow_min_cost; | |
| bipartite_betweenness_centrality; | |
| simrank_similarity; | |
| minimal_branching; | |
| dominating_set; | |
| contracted_nodes; | |
| single_source_dijkstra; | |
| read_adjlist; | |
| is_triad; | |
| bipartite_average_clustering; | |
| randomized_partitioning; | |
| is_equitable; | |
| from_graph6_bytes; | |
| descendants; | |
| preferential_attachment_graph; | |
| single_source_bellman_ford_path_length; | |
| all_pairs_bellman_ford_path; | |
| fiedler_vector; | |
| is_attracting_component; | |
| cartesian_product; | |
| random_graph; | |
| double_edge_swap; | |
| connected_components; | |
| parse_pajek; | |
| core_number; | |
| weakly_connected_components; | |
| communicability_exp; | |
| prefix_tree; | |
| group_degree_centrality; | |
| find_cliques; | |
| random_labeled_rooted_forest; | |
| petersen_graph; | |
| expected_degree_graph; | |
| vf2pp_isomorphism; | |
| random_cograph; | |
| approximate_local_node_connectivity; | |
| generate_random_paths; | |
| build_flow_dict; | |
| barbell_graph; | |
| random_powerlaw_tree; | |
| compose_all; | |
| to_pandas_adjacency; | |
| single_source_bellman_ford_path; | |
| detect_unboundedness; | |
| average_clustering; | |
| octahedral_graph; | |
| treewidth_decomp; | |
| group_closeness_centrality; | |
| chvatal_graph; | |
| chordal_graph_cliques; | |
| subgraph_centrality_exp; | |
| graph_edit_distance; | |
| from_numpy_array; | |
| nonisomorphic_trees; | |
| number_of_isolates; | |
| edge_current_flow_betweenness_centrality_subset; | |
| is_simple_path; | |
| node_attribute_xy; | |
| bridge_components; | |
| powerlaw_cluster_graph; | |
| strategy_connected_sequential_dfs; | |
| is_bipartite; | |
| random_shell_graph; | |
| topological_sort; | |
| subgraph_centrality; | |
| from_biadjacency_matrix; | |
| random_uniform_k_out_graph; | |
| is_distance_regular; | |
| boundary_expansion; | |
| trophic_incoherence_parameter; | |
| voronoi_cells; | |
| attribute_mixing_matrix; | |
| dijkstra_path; | |
| planted_partition_graph; | |
| moral_graph; | |
| dfs_predecessors; | |
| treewidth_min_fill_in; | |
| wheel_graph; | |
| all_pairs_shortest_path_length -> single_source_shortest_path_length [label=75]; | |
| boruvka_mst_edges -> edge_boundary [label=21]; | |
| greedy_k_edge_augmentation -> is_k_edge_connected [label=22]; | |
| greedy_k_edge_augmentation -> is_locally_k_edge_connected [label=116]; | |
| greedy_k_edge_augmentation -> complement_edges [label=1]; | |
| minimum_cut_value -> boykov_kolmogorov [label=1]; | |
| minimum_cut_value -> preflow_push [label=1]; | |
| minimum_cut_value -> shortest_augmenting_path [label=1]; | |
| immediate_dominators -> dfs_postorder_nodes [label=1]; | |
| closeness_centrality -> single_source_shortest_path_length [label=100]; | |
| closeness_centrality -> single_source_dijkstra_path_length [label=5]; | |
| dag_longest_path -> topological_sort [label=1]; | |
| condensation -> strongly_connected_components [label=1]; | |
| maximum_flow_value -> preflow_push [label=1]; | |
| maximum_flow_value -> dinitz [label=1]; | |
| maximum_flow_value -> shortest_augmenting_path [label=1]; | |
| maximum_flow_value -> boykov_kolmogorov [label=1]; | |
| maximum_flow_value -> edmonds_karp [label=1]; | |
| average_node_connectivity -> build_auxiliary_node_connectivity [label=1]; | |
| average_node_connectivity -> build_residual_network [label=1]; | |
| average_node_connectivity -> local_node_connectivity [label=12]; | |
| relaxed_caveman_graph -> caveman_graph [label=1]; | |
| current_flow_betweenness_centrality -> connected_components [label=1]; | |
| current_flow_betweenness_centrality -> flow_matrix_row [label=1]; | |
| current_flow_betweenness_centrality -> is_connected [label=1]; | |
| current_flow_betweenness_centrality -> relabel_nodes [label=1]; | |
| current_flow_betweenness_centrality -> shortest_path_length [label=3]; | |
| eccentricity -> shortest_path_length [label=50]; | |
| traveling_salesman_problem -> all_pairs_dijkstra [label=1]; | |
| traveling_salesman_problem -> christofides [label=1]; | |
| traveling_salesman_problem -> threshold_accepting_tsp [label=1]; | |
| traveling_salesman_problem -> simulated_annealing_tsp [label=1]; | |
| traveling_salesman_problem -> is_strongly_connected [label=1]; | |
| traveling_salesman_problem -> greedy_tsp [label=1]; | |
| traveling_salesman_problem -> asadpour_atsp [label=1]; | |
| constraint -> local_constraint [label=20]; | |
| local_bridges -> shortest_path_length [label=9]; | |
| group_in_degree_centrality -> group_degree_centrality [label=1]; | |
| minimum_cycle_basis -> connected_components [label=1]; | |
| minimum_cycle_basis -> minimum_spanning_edges [label=3]; | |
| minimum_cycle_basis -> shortest_path [label=21]; | |
| minimum_cycle_basis -> shortest_path_length [label=168]; | |
| girvan_newman -> connected_components [label=22]; | |
| girvan_newman -> edge_betweenness_centrality [label=22]; | |
| girvan_newman -> number_connected_components [label=10]; | |
| shortest_path_length -> all_pairs_bellman_ford_path_length [label=1]; | |
| shortest_path_length -> bellman_ford_path_length [label=1]; | |
| shortest_path_length -> all_pairs_dijkstra_path_length [label=1]; | |
| shortest_path_length -> single_source_dijkstra_path_length [label=1]; | |
| shortest_path_length -> bidirectional_shortest_path [label=1]; | |
| shortest_path_length -> single_source_bellman_ford_path_length [label=1]; | |
| shortest_path_length -> all_pairs_shortest_path_length [label=1]; | |
| shortest_path_length -> dijkstra_path_length [label=1]; | |
| shortest_path_length -> single_source_shortest_path_length [label=1]; | |
| minimum_node_cut -> build_auxiliary_node_connectivity [label=1]; | |
| minimum_node_cut -> build_residual_network [label=1]; | |
| minimum_node_cut -> is_weakly_connected [label=1]; | |
| minimum_node_cut -> minimum_st_node_cut [label=98]; | |
| minimum_node_cut -> is_connected [label=1]; | |
| disjoint_union_all -> complete_graph [label=16]; | |
| disjoint_union_all -> union_all [label=1]; | |
| visibility_graph -> path_graph [label=1]; | |
| held_karp_ascent -> is_weakly_connected [label=120]; | |
| held_karp_ascent -> minimum_spanning_arborescence [label=2100]; | |
| local_efficiency -> global_efficiency [label=9]; | |
| newman_betweenness_centrality -> predecessor [label=77]; | |
| newman_betweenness_centrality -> dijkstra_predecessor_and_distance [label=6]; | |
| ramsey_R2 -> ramsey_R2 [label=2]; | |
| local_node_connectivity -> build_auxiliary_node_connectivity [label=1]; | |
| local_node_connectivity -> maximum_flow_value [label=1]; | |
| frucht_graph -> cycle_graph [label=1]; | |
| christofides -> eulerian_circuit [label=1]; | |
| christofides -> min_weight_matching [label=1]; | |
| christofides -> minimum_spanning_tree [label=1]; | |
| wiener_index -> is_connected [label=1]; | |
| wiener_index -> shortest_path_length [label=1]; | |
| wiener_index -> is_strongly_connected [label=1]; | |
| effective_size -> normalized_mutual_weight [label=148]; | |
| effective_size -> ego_graph [label=7]; | |
| lattice_reference -> local_edge_connectivity [label=184]; | |
| parse_gml -> relabel_nodes [label=1]; | |
| all_pairs_node_connectivity -> build_auxiliary_node_connectivity [label=1]; | |
| all_pairs_node_connectivity -> build_residual_network [label=1]; | |
| all_pairs_node_connectivity -> local_node_connectivity [label=190]; | |
| agraph_read_dot -> from_agraph [label=1]; | |
| join_trees -> empty_graph [label=1]; | |
| join_trees -> convert_node_labels_to_integers [label=2]; | |
| attracting_components -> condensation [label=1]; | |
| attracting_components -> strongly_connected_components [label=1]; | |
| sets -> is_connected [label=1]; | |
| sets -> color [label=1]; | |
| sets -> is_weakly_connected [label=1]; | |
| directed_combinatorial_laplacian_matrix -> is_strongly_connected [label=1]; | |
| directed_combinatorial_laplacian_matrix -> to_scipy_sparse_array [label=1]; | |
| directed_combinatorial_laplacian_matrix -> is_aperiodic [label=1]; | |
| node_connectivity -> is_connected [label=1]; | |
| node_connectivity -> build_auxiliary_node_connectivity [label=1]; | |
| node_connectivity -> build_residual_network [label=1]; | |
| node_connectivity -> local_node_connectivity [label=100]; | |
| node_connectivity -> is_weakly_connected [label=1]; | |
| hamiltonian_path -> hamiltonian_path [label=1]; | |
| minimum_edge_cut -> build_auxiliary_edge_connectivity [label=1]; | |
| minimum_edge_cut -> build_residual_network [label=1]; | |
| minimum_edge_cut -> dominating_set [label=5]; | |
| minimum_edge_cut -> is_connected [label=1]; | |
| minimum_edge_cut -> minimum_st_edge_cut [label=34]; | |
| minimum_edge_cut -> is_weakly_connected [label=1]; | |
| minimum_st_node_cut -> build_auxiliary_node_connectivity [label=1]; | |
| minimum_st_node_cut -> minimum_st_edge_cut [label=1]; | |
| all_pairs_dijkstra -> single_source_dijkstra [label=15]; | |
| partial_k_edge_augmentation -> k_edge_subgraphs [label=1]; | |
| partial_k_edge_augmentation -> k_edge_augmentation [label=5]; | |
| all_node_cuts -> antichains [label=37]; | |
| all_node_cuts -> build_auxiliary_node_connectivity [label=1]; | |
| all_node_cuts -> build_residual_network [label=1]; | |
| all_node_cuts -> condensation [label=37]; | |
| all_node_cuts -> edmonds_karp [label=247]; | |
| all_node_cuts -> is_connected [label=2]; | |
| all_node_cuts -> node_connectivity [label=1]; | |
| all_node_cuts -> transitive_closure [label=37]; | |
| get_counterexample_recursive -> check_planarity_recursive [label=29]; | |
| get_counterexample_recursive -> from_dict_of_dicts [label=1]; | |
| simple_cycles -> from_edgelist [label=1]; | |
| simple_cycles -> strongly_connected_components [label=11]; | |
| simple_cycles -> biconnected_components [label=46]; | |
| spectral_ordering -> connected_components [label=3]; | |
| spectral_ordering -> laplacian_matrix [label=2]; | |
| spectral_ordering -> shortest_path_length [label=4]; | |
| floyd_warshall_numpy -> to_numpy_array [label=1]; | |
| read_gml -> relabel_nodes [label=1]; | |
| global_efficiency -> all_pairs_shortest_path_length [label=1]; | |
| is_semiconnected -> is_weakly_connected [label=1]; | |
| is_semiconnected -> condensation [label=1]; | |
| is_semiconnected -> topological_sort [label=1]; | |
| havel_hakimi_graph -> is_graphical [label=1]; | |
| havel_hakimi_graph -> empty_graph [label=1]; | |
| tournament_is_strongly_connected -> is_reachable [label=16]; | |
| normalized_mutual_weight -> mutual_weight [label=7]; | |
| eulerize -> from_dict_of_dicts [label=1]; | |
| eulerize -> from_edgelist [label=1]; | |
| eulerize -> is_connected [label=1]; | |
| eulerize -> max_weight_matching [label=1]; | |
| eulerize -> shortest_path [label=45]; | |
| is_eulerian -> is_connected [label=1]; | |
| is_eulerian -> is_strongly_connected [label=1]; | |
| periphery -> eccentricity [label=1]; | |
| periphery -> shortest_path_length [label=7]; | |
| edge_connectivity -> build_auxiliary_edge_connectivity [label=1]; | |
| edge_connectivity -> build_residual_network [label=1]; | |
| edge_connectivity -> is_weakly_connected [label=1]; | |
| edge_connectivity -> local_edge_connectivity [label=34]; | |
| edge_connectivity -> dominating_set [label=15]; | |
| edge_connectivity -> is_connected [label=1]; | |
| strategy_connected_sequential_bfs -> strategy_connected_sequential [label=1]; | |
| k_corona -> core_number [label=1]; | |
| bfs_predecessors -> bfs_edges [label=1]; | |
| hits -> adjacency_matrix [label=1]; | |
| all_pairs_dijkstra_path_length -> single_source_dijkstra_path_length [label=25]; | |
| is_locally_k_edge_connected -> local_edge_connectivity [label=1]; | |
| is_locally_k_edge_connected -> has_path [label=1]; | |
| ancestors -> bfs_edges [label=1]; | |
| kosaraju_strongly_connected_components -> dfs_postorder_nodes [label=1]; | |
| kosaraju_strongly_connected_components -> dfs_preorder_nodes [label=10]; | |
| inverse_line_graph -> from_edgelist [label=1]; | |
| inverse_line_graph -> empty_graph [label=1]; | |
| random_reference -> local_edge_connectivity [label=735]; | |
| k_edge_components -> connected_components [label=1]; | |
| k_edge_components -> minimum_cut [label=11]; | |
| k_edge_components -> bridge_components [label=1]; | |
| k_edge_components -> strongly_connected_components [label=1]; | |
| color -> isolates [label=1]; | |
| shortest_path -> single_source_dijkstra_path [label=1]; | |
| shortest_path -> bellman_ford_path [label=1]; | |
| shortest_path -> all_pairs_dijkstra_path [label=1]; | |
| shortest_path -> all_pairs_bellman_ford_path [label=1]; | |
| shortest_path -> bidirectional_shortest_path [label=1]; | |
| shortest_path -> bidirectional_dijkstra [label=1]; | |
| shortest_path -> single_source_shortest_path [label=1]; | |
| shortest_path -> single_source_bellman_ford_path [label=1]; | |
| shortest_path -> all_pairs_shortest_path [label=1]; | |
| omega -> average_clustering [label=12]; | |
| omega -> average_shortest_path_length [label=11]; | |
| omega -> lattice_reference [label=10]; | |
| omega -> random_reference [label=10]; | |
| k_edge_augmentation -> is_k_edge_connected [label=1]; | |
| k_edge_augmentation -> partial_k_edge_augmentation [label=1]; | |
| k_edge_augmentation -> bridge_augmentation [label=1]; | |
| k_edge_augmentation -> one_edge_augmentation [label=1]; | |
| k_edge_augmentation -> complement_edges [label=1]; | |
| k_edge_augmentation -> greedy_k_edge_augmentation [label=1]; | |
| root_to_leaf_paths -> all_simple_paths [label=16]; | |
| all_pairs_shortest_path -> single_source_shortest_path [label=16]; | |
| is_reachable -> is_simple_path [label=450]; | |
| transitive_closure_dag -> descendants_at_distance [label=29]; | |
| transitive_closure_dag -> topological_sort [label=1]; | |
| transitive_closure -> edge_bfs [label=202]; | |
| transitive_closure -> descendants [label=4]; | |
| min_edge_dominating_set -> maximal_matching [label=1]; | |
| approximate_diameter -> eccentricity [label=2]; | |
| approximate_diameter -> shortest_path_length [label=2]; | |
| edge_disjoint_paths -> build_auxiliary_edge_connectivity [label=1]; | |
| edge_disjoint_paths -> shortest_augmenting_path [label=1]; | |
| edge_disjoint_paths -> dinitz [label=1]; | |
| edge_disjoint_paths -> boykov_kolmogorov [label=1]; | |
| edge_disjoint_paths -> edmonds_karp [label=1]; | |
| edge_disjoint_paths -> preflow_push [label=1]; | |
| bridges -> chain_decomposition [label=1]; | |
| bridges -> from_dict_of_dicts [label=1]; | |
| bridges -> node_connected_component [label=1]; | |
| greedy_color -> strategy_independent_set [label=1]; | |
| greedy_color -> strategy_largest_first [label=1]; | |
| greedy_color -> strategy_connected_sequential_dfs [label=1]; | |
| greedy_color -> strategy_saturation_largest_first [label=1]; | |
| greedy_color -> strategy_smallest_last [label=1]; | |
| greedy_color -> strategy_connected_sequential_bfs [label=1]; | |
| greedy_color -> strategy_connected_sequential [label=1]; | |
| greedy_color -> strategy_random_sequential [label=1]; | |
| girth -> bfs_labeled_edges [label=46]; | |
| k_crust -> core_number [label=1]; | |
| compose -> compose_all [label=1]; | |
| from_pandas_adjacency -> from_numpy_array [label=1]; | |
| from_pandas_adjacency -> relabel_nodes [label=1]; | |
| read_weighted_edgelist -> read_edgelist [label=1]; | |
| chordless_cycles -> biconnected_components [label=500]; | |
| chordless_cycles -> from_edgelist [label=1]; | |
| chordless_cycles -> strongly_connected_components [label=42]; | |
| k_components -> all_node_cuts [label=6]; | |
| k_components -> biconnected_components [label=1]; | |
| k_components -> connected_components [label=17]; | |
| k_components -> node_connectivity [label=6]; | |
| min_cost_flow -> network_simplex [label=1]; | |
| find_asteroidal_triple -> complement [label=1]; | |
| find_asteroidal_triple -> create_component_structure [label=1]; | |
| second_order_centrality -> is_connected [label=1]; | |
| second_order_centrality -> from_dict_of_dicts [label=1]; | |
| second_order_centrality -> to_numpy_array [label=1]; | |
| tutte_polynomial -> bridges [label=511]; | |
| tutte_polynomial -> contracted_edge [label=255]; | |
| tutte_polynomial -> from_dict_of_dicts [label=1]; | |
| adjacency_matrix -> to_scipy_sparse_array [label=1]; | |
| vf2pp_all_isomorphisms -> bfs_layers [label=10]; | |
| vf2pp_all_isomorphisms -> empty_graph [label=1]; | |
| barycenter -> shortest_path_length [label=1]; | |
| contracted_edge -> contracted_nodes [label=1]; | |
| triangular_lattice_graph -> contracted_nodes [label=10]; | |
| triangular_lattice_graph -> empty_graph [label=1]; | |
| clique_removal -> ramsey_R2 [label=31]; | |
| number_of_walks -> adjacency_matrix [label=1]; | |
| quotient_graph -> empty_graph [label=1]; | |
| quotient_graph -> is_partition [label=1]; | |
| quotient_graph -> relabel_nodes [label=1]; | |
| diameter -> shortest_path_length [label=4]; | |
| diameter -> eccentricity [label=1]; | |
| sudoku_graph -> empty_graph [label=1]; | |
| connected_watts_strogatz_graph -> is_connected [label=1]; | |
| connected_watts_strogatz_graph -> watts_strogatz_graph [label=1]; | |
| k_core -> core_number [label=1]; | |
| random_tree -> empty_graph [label=1]; | |
| random_tree -> from_prufer_sequence [label=1]; | |
| random_tree -> dfs_edges [label=1]; | |
| read_graphml -> from_dict_of_dicts [label=4]; | |
| dag_longest_path_length -> dag_longest_path [label=1]; | |
| junction_tree -> chordal_graph_cliques [label=1]; | |
| junction_tree -> complete_to_chordal_graph [label=1]; | |
| junction_tree -> maximum_spanning_tree [label=1]; | |
| junction_tree -> moral_graph [label=1]; | |
| chain_decomposition -> dfs_labeled_edges [label=1]; | |
| scale_free_graph -> from_edgelist [label=1]; | |
| from_pandas_edgelist -> empty_graph [label=1]; | |
| current_flow_betweenness_centrality_subset -> connected_components [label=1]; | |
| current_flow_betweenness_centrality_subset -> flow_matrix_row [label=1]; | |
| current_flow_betweenness_centrality_subset -> is_connected [label=1]; | |
| current_flow_betweenness_centrality_subset -> relabel_nodes [label=1]; | |
| current_flow_betweenness_centrality_subset -> shortest_path_length [label=3]; | |
| get_counterexample -> check_planarity [label=29]; | |
| get_counterexample -> from_dict_of_dicts [label=1]; | |
| find_induced_nodes -> is_chordal [label=1]; | |
| find_induced_nodes -> from_dict_of_dicts [label=1]; | |
| modularity_matrix -> to_scipy_sparse_array [label=1]; | |
| eigenvector_centrality_numpy -> to_scipy_sparse_array [label=1]; | |
| minimum_branching -> maximum_branching [label=1]; | |
| bipartite_parse_edgelist -> empty_graph [label=1]; | |
| connected_double_edge_swap -> is_connected [label=21]; | |
| connected_double_edge_swap -> has_path [label=31]; | |
| chromatic_polynomial -> contracted_edge [label=4095]; | |
| chromatic_polynomial -> from_dict_of_dicts [label=1]; | |
| algebraic_connectivity -> connected_components [label=1]; | |
| algebraic_connectivity -> is_connected [label=1]; | |
| algebraic_connectivity -> laplacian_matrix [label=1]; | |
| algebraic_connectivity -> shortest_path_length [label=2]; | |
| all_pairs_dijkstra_path -> single_source_dijkstra_path [label=16]; | |
| minimal_d_separator -> is_directed_acyclic_graph [label=1]; | |
| minimal_d_separator -> ancestors [label=2]; | |
| minimal_d_separator -> moral_graph [label=1]; | |
| general_random_intersection_graph -> empty_graph [label=1]; | |
| general_random_intersection_graph -> projected_graph [label=1]; | |
| spectral_graph_forge -> from_numpy_array [label=1]; | |
| spectral_graph_forge -> to_numpy_array [label=1]; | |
| make_max_clique_graph -> find_cliques [label=1]; | |
| make_max_clique_graph -> empty_graph [label=1]; | |
| random_tournament -> from_edgelist [label=1]; | |
| complete_to_chordal_graph -> has_path [label=714]; | |
| complete_to_chordal_graph -> is_chordal [label=1]; | |
| trophic_differences -> trophic_levels [label=1]; | |
| from_dict_of_dicts -> empty_graph [label=1]; | |
| is_minimal_d_separator -> ancestors [label=2]; | |
| is_minimal_d_separator -> d_separated [label=1]; | |
| is_minimal_d_separator -> moral_graph [label=1]; | |
| has_eulerian_path -> is_connected [label=1]; | |
| has_eulerian_path -> is_eulerian [label=1]; | |
| has_eulerian_path -> is_weakly_connected [label=1]; | |
| reciprocity -> overall_reciprocity [label=1]; | |
| non_randomness -> is_connected [label=1]; | |
| non_randomness -> to_numpy_array [label=1]; | |
| non_randomness -> label_propagation_communities [label=1]; | |
| has_path -> shortest_path [label=1]; | |
| waxman_graph -> empty_graph [label=1]; | |
| mycielskian -> convert_node_labels_to_integers [label=1]; | |
| effective_graph_resistance -> is_connected [label=1]; | |
| effective_graph_resistance -> laplacian_spectrum [label=1]; | |
| has_bridges -> bridges [label=1]; | |
| harmonic_centrality -> shortest_path_length [label=7]; | |
| kemeny_constant -> is_connected [label=1]; | |
| kemeny_constant -> adjacency_matrix [label=1]; | |
| read_p2g -> parse_p2g [label=1]; | |
| degree_sequence_tree -> empty_graph [label=1]; | |
| random_unlabeled_tree -> empty_graph [label=10]; | |
| optimize_graph_edit_distance -> optimize_edit_paths [label=1]; | |
| average_shortest_path_length -> floyd_warshall_numpy [label=1]; | |
| average_shortest_path_length -> is_connected [label=1]; | |
| average_shortest_path_length -> single_source_shortest_path_length [label=50]; | |
| average_shortest_path_length -> single_source_dijkstra_path_length [label=7]; | |
| average_shortest_path_length -> single_source_bellman_ford_path_length [label=7]; | |
| average_shortest_path_length -> floyd_warshall [label=1]; | |
| average_shortest_path_length -> is_strongly_connected [label=1]; | |
| resistance_distance -> is_connected [label=1]; | |
| resistance_distance -> laplacian_matrix [label=1]; | |
| k_truss -> isolates [label=3]; | |
| grid_graph -> cartesian_product [label=8]; | |
| grid_graph -> path_graph [label=9]; | |
| grid_graph -> relabel_nodes [label=1]; | |
| grid_graph -> cycle_graph [label=3]; | |
| grid_graph -> empty_graph [label=1]; | |
| gnmk_random_graph -> complete_bipartite_graph [label=1]; | |
| minimum_st_edge_cut -> minimum_cut [label=1]; | |
| minimum_st_edge_cut -> build_auxiliary_edge_connectivity [label=1]; | |
| uniform_random_intersection_graph -> projected_graph [label=1]; | |
| uniform_random_intersection_graph -> random_graph [label=1]; | |
| union_all -> relabel_nodes [label=3]; | |
| union_all -> convert_node_labels_to_integers [label=17]; | |
| directed_havel_hakimi_graph -> empty_graph [label=1]; | |
| bipartite_closeness_centrality -> single_source_shortest_path_length [label=32]; | |
| intersection_array -> all_pairs_shortest_path_length [label=1]; | |
| normalized_laplacian_matrix -> to_scipy_sparse_array [label=1]; | |
| negative_edge_cycle -> bellman_ford_predecessor_and_distance [label=1]; | |
| closeness_vitality -> wiener_index [label=2]; | |
| closeness_vitality -> closeness_vitality [label=3]; | |
| shortest_augmenting_path -> build_residual_network [label=1]; | |
| shortest_augmenting_path -> edmonds_karp_core [label=1]; | |
| degree_assortativity_coefficient -> degree_mixing_matrix [label=1]; | |
| hkn_harary_graph -> path_graph [label=1]; | |
| hkn_harary_graph -> empty_graph [label=1]; | |
| descendants_at_distance -> bfs_layers [label=1]; | |
| lukes_partitioning -> descendants [label=64]; | |
| lukes_partitioning -> is_tree [label=1]; | |
| lukes_partitioning -> dfs_tree [label=1]; | |
| weighted_bridge_augmentation -> is_connected [label=1]; | |
| weighted_bridge_augmentation -> one_edge_augmentation [label=1]; | |
| weighted_bridge_augmentation -> bridge_components [label=1]; | |
| weighted_bridge_augmentation -> collapse [label=1]; | |
| weighted_bridge_augmentation -> dfs_tree [label=1]; | |
| weighted_bridge_augmentation -> minimum_spanning_arborescence [label=1]; | |
| weighted_bridge_augmentation -> reverse [label=1]; | |
| weighted_bridge_augmentation -> tree_all_pairs_lowest_common_ancestor [label=1]; | |
| normalized_cut_size -> cut_size [label=1]; | |
| normalized_cut_size -> volume [label=2]; | |
| pagerank -> to_scipy_sparse_array [label=1]; | |
| minimum_weight_full_matching -> biadjacency_matrix [label=1]; | |
| minimum_weight_full_matching -> sets [label=1]; | |
| katz_centrality_numpy -> adjacency_matrix [label=1]; | |
| astar_path_length -> astar_path [label=1]; | |
| attribute_mixing_dict -> node_attribute_xy [label=1]; | |
| random_spanning_tree -> contracted_edge [label=80]; | |
| random_spanning_tree -> contracted_nodes [label=19]; | |
| random_spanning_tree -> from_dict_of_dicts [label=9]; | |
| random_spanning_tree -> total_spanning_tree_weight [label=88]; | |
| from_nested_tuple -> bfs_edges [label=1]; | |
| from_nested_tuple -> empty_graph [label=4]; | |
| from_nested_tuple -> join_trees [label=3]; | |
| from_nested_tuple -> relabel_nodes [label=1]; | |
| sedgewick_maze_graph -> empty_graph [label=1]; | |
| strongly_connected_components_recursive -> strongly_connected_components [label=1]; | |
| approximate_all_pairs_node_connectivity -> approximate_local_node_connectivity [label=190]; | |
| parse_edgelist -> empty_graph [label=1]; | |
| center -> eccentricity [label=1]; | |
| center -> shortest_path_length [label=7]; | |
| tree_all_pairs_lowest_common_ancestor -> dfs_postorder_nodes [label=1]; | |
| minimum_cut -> edmonds_karp [label=1]; | |
| minimum_cut -> shortest_path_length [label=1]; | |
| minimum_cut -> boykov_kolmogorov [label=1]; | |
| minimum_cut -> dinitz [label=1]; | |
| minimum_cut -> preflow_push [label=1]; | |
| minimum_cut -> shortest_augmenting_path [label=1]; | |
| relabel_nodes -> from_edgelist [label=1]; | |
| relabel_nodes -> topological_sort [label=1]; | |
| conductance -> cut_size [label=1]; | |
| conductance -> volume [label=2]; | |
| all_pairs_lowest_common_ancestor -> ancestors [label=11]; | |
| all_pairs_lowest_common_ancestor -> is_directed_acyclic_graph [label=1]; | |
| random_unlabeled_rooted_forest -> empty_graph [label=10]; | |
| metric_closure -> all_pairs_dijkstra [label=1]; | |
| check_planarity -> get_counterexample [label=1]; | |
| louvain_communities -> louvain_partitions [label=1]; | |
| all_pairs_bellman_ford_path_length -> single_source_bellman_ford_path_length [label=7]; | |
| incremental_closeness_centrality -> single_source_shortest_path_length [label=5]; | |
| incremental_closeness_centrality -> closeness_centrality [label=1]; | |
| naive_greedy_modularity_communities -> modularity [label=6545]; | |
| k_random_intersection_graph -> empty_graph [label=1]; | |
| k_random_intersection_graph -> projected_graph [label=1]; | |
| local_reaching_centrality -> shortest_path [label=1]; | |
| bethe_hessian_spectrum -> bethe_hessian_matrix [label=1]; | |
| bfs_successors -> bfs_edges [label=1]; | |
| minimum_spanning_edges -> kruskal_mst_edges [label=1]; | |
| minimum_spanning_edges -> boruvka_mst_edges [label=1]; | |
| minimum_spanning_edges -> prim_mst_edges [label=1]; | |
| mycielski_graph -> mycielskian [label=1]; | |
| mycielski_graph -> path_graph [label=1]; | |
| mycielski_graph -> empty_graph [label=1]; | |
| is_at_free -> find_asteroidal_triple [label=1]; | |
| barabasi_albert_graph -> star_graph [label=1]; | |
| make_clique_bipartite -> empty_graph [label=1]; | |
| make_clique_bipartite -> find_cliques [label=1]; | |
| tetrahedral_graph -> complete_graph [label=1]; | |
| random_k_out_graph -> empty_graph [label=1]; | |
| is_tree -> is_connected [label=1]; | |
| is_tree -> is_weakly_connected [label=1]; | |
| soft_random_geometric_graph -> empty_graph [label=1]; | |
| random_lobster -> path_graph [label=1]; | |
| is_strongly_connected -> strongly_connected_components [label=1]; | |
| dag_to_branching -> has_cycle [label=1]; | |
| dag_to_branching -> prefix_tree [label=1]; | |
| dag_to_branching -> root_to_leaf_paths [label=1]; | |
| modularity_spectrum -> modularity_matrix [label=1]; | |
| modularity_spectrum -> directed_modularity_matrix [label=1]; | |
| LCF_graph -> cycle_graph [label=1]; | |
| LCF_graph -> empty_graph [label=1]; | |
| root_trees -> bfs_edges [label=2]; | |
| caveman_graph -> empty_graph [label=1]; | |
| is_graphical -> is_valid_degree_sequence_erdos_gallai [label=1]; | |
| is_graphical -> is_valid_degree_sequence_havel_hakimi [label=1]; | |
| antichains -> topological_sort [label=1]; | |
| antichains -> transitive_closure_dag [label=1]; | |
| gomory_hu_tree -> build_residual_network [label=1]; | |
| gomory_hu_tree -> minimum_cut [label=33]; | |
| general_k_edge_subgraphs -> connected_components [label=4]; | |
| general_k_edge_subgraphs -> minimum_edge_cut [label=8]; | |
| general_k_edge_subgraphs -> strongly_connected_components [label=1]; | |
| random_regular_graph -> empty_graph [label=1]; | |
| attribute_assortativity_coefficient -> attribute_mixing_matrix [label=1]; | |
| approximate_node_connectivity -> approximate_local_node_connectivity [label=19]; | |
| approximate_node_connectivity -> is_weakly_connected [label=1]; | |
| approximate_node_connectivity -> is_connected [label=1]; | |
| read_graph6 -> from_graph6_bytes [label=4]; | |
| balanced_tree -> full_rary_tree [label=1]; | |
| all_shortest_paths -> dijkstra_predecessor_and_distance [label=1]; | |
| all_shortest_paths -> predecessor [label=1]; | |
| all_shortest_paths -> bellman_ford_predecessor_and_distance [label=1]; | |
| dual_barabasi_albert_graph -> barabasi_albert_graph [label=1]; | |
| dual_barabasi_albert_graph -> star_graph [label=1]; | |
| is_k_edge_connected -> edge_connectivity [label=1]; | |
| is_k_edge_connected -> has_bridges [label=1]; | |
| is_k_edge_connected -> is_connected [label=1]; | |
| bfs_beam_edges -> generic_bfs_edges [label=1]; | |
| radius -> shortest_path_length [label=7]; | |
| radius -> eccentricity [label=1]; | |
| harmonic_function -> to_scipy_sparse_array [label=1]; | |
| create_component_structure -> connected_components [label=15]; | |
| approximate_current_flow_betweenness_centrality -> connected_components [label=1]; | |
| approximate_current_flow_betweenness_centrality -> is_connected [label=1]; | |
| approximate_current_flow_betweenness_centrality -> laplacian_matrix [label=1]; | |
| approximate_current_flow_betweenness_centrality -> relabel_nodes [label=1]; | |
| approximate_current_flow_betweenness_centrality -> shortest_path_length [label=3]; | |
| read_leda -> parse_leda [label=1]; | |
| binomial_tree -> empty_graph [label=1]; | |
| chordal_graph_treewidth -> is_chordal [label=1]; | |
| chordal_graph_treewidth -> chordal_graph_cliques [label=1]; | |
| extended_barabasi_albert_graph -> empty_graph [label=1]; | |
| approximate_k_components -> approximate_local_node_connectivity [label=5130]; | |
| approximate_k_components -> biconnected_components [label=28]; | |
| approximate_k_components -> connected_components [label=1]; | |
| approximate_k_components -> core_number [label=35]; | |
| approximate_k_components -> k_core [label=35]; | |
| panther_similarity -> generate_random_paths [label=1]; | |
| laplacian_centrality -> directed_laplacian_matrix [label=1]; | |
| laplacian_centrality -> laplacian_matrix [label=1]; | |
| communicability -> to_numpy_array [label=1]; | |
| dominance_frontiers -> immediate_dominators [label=1]; | |
| trivial_graph -> empty_graph [label=1]; | |
| is_kl_connected -> shortest_path [label=256]; | |
| configuration_model -> empty_graph [label=2]; | |
| node_clique_number -> find_cliques [label=2]; | |
| node_clique_number -> ego_graph [label=2]; | |
| label_propagation_communities -> greedy_color [label=1]; | |
| tree_isomorphism -> center [label=2]; | |
| tree_isomorphism -> is_tree [label=2]; | |
| tree_isomorphism -> rooted_tree_isomorphism [label=2]; | |
| equitable_color -> pad_graph [label=1]; | |
| equitable_color -> relabel_nodes [label=1]; | |
| recursive_simple_cycles -> strongly_connected_components [label=30]; | |
| pydot_read_dot -> from_pydot [label=1]; | |
| from_scipy_sparse_array -> empty_graph [label=1]; | |
| k_shell -> core_number [label=1]; | |
| local_constraint -> normalized_mutual_weight [label=13]; | |
| maximum_branching -> is_branching [label=1]; | |
| maximum_branching -> shortest_path [label=8]; | |
| random_unlabeled_rooted_tree -> empty_graph [label=10]; | |
| current_flow_closeness_centrality -> connected_components [label=1]; | |
| current_flow_closeness_centrality -> is_connected [label=1]; | |
| current_flow_closeness_centrality -> laplacian_matrix [label=1]; | |
| current_flow_closeness_centrality -> relabel_nodes [label=1]; | |
| current_flow_closeness_centrality -> shortest_path_length [label=3]; | |
| turan_graph -> complete_multipartite_graph [label=1]; | |
| capacity_scaling -> negative_edge_cycle [label=1]; | |
| from_dict_of_lists -> empty_graph [label=1]; | |
| global_reaching_centrality -> local_reaching_centrality [label=5]; | |
| global_reaching_centrality -> shortest_path [label=1]; | |
| spectral_bisection -> fiedler_vector [label=1]; | |
| maximum_flow -> build_flow_dict [label=1]; | |
| maximum_flow -> shortest_augmenting_path [label=1]; | |
| maximum_flow -> preflow_push [label=1]; | |
| ladder_graph -> empty_graph [label=1]; | |
| triads_by_type -> all_triads [label=1]; | |
| triads_by_type -> triad_type [label=120]; | |
| single_source_dijkstra_path -> multi_source_dijkstra_path [label=1]; | |
| all_pairs_all_shortest_paths -> single_source_all_shortest_paths [label=5]; | |
| steiner_tree -> minimum_spanning_edges [label=2]; | |
| steiner_tree -> multi_source_dijkstra_path [label=1]; | |
| steiner_tree -> shortest_path [label=8]; | |
| steiner_tree -> metric_closure [label=1]; | |
| gnc_graph -> empty_graph [label=1]; | |
| single_source_all_shortest_paths -> bellman_ford_predecessor_and_distance [label=1]; | |
| single_source_all_shortest_paths -> dijkstra_predecessor_and_distance [label=1]; | |
| single_source_all_shortest_paths -> predecessor [label=1]; | |
| pappus_graph -> LCF_graph [label=1]; | |
| margulis_gabber_galil_graph -> empty_graph [label=1]; | |
| one_exchange -> cut_size [label=19]; | |
| estrada_index -> subgraph_centrality [label=1]; | |
| is_biconnected -> biconnected_components [label=1]; | |
| cycle_graph -> empty_graph [label=1]; | |
| fast_gnp_random_graph -> empty_graph [label=1]; | |
| fast_gnp_random_graph -> gnp_random_graph [label=1]; | |
| fast_gnp_random_graph -> from_dict_of_dicts [label=1]; | |
| edge_load_centrality -> predecessor [label=7]; | |
| asyn_fluidc -> is_connected [label=1]; | |
| maximum_spanning_tree -> maximum_spanning_edges [label=1]; | |
| unconstrained_one_edge_augmentation -> collapse [label=1]; | |
| unconstrained_one_edge_augmentation -> connected_components [label=1]; | |
| adjacency_spectrum -> adjacency_matrix [label=1]; | |
| hoffman_singleton_graph -> convert_node_labels_to_integers [label=1]; | |
| bridge_augmentation -> weighted_bridge_augmentation [label=1]; | |
| bridge_augmentation -> unconstrained_bridge_augmentation [label=1]; | |
| directed_modularity_matrix -> to_scipy_sparse_array [label=1]; | |
| directed_laplacian_matrix -> is_strongly_connected [label=1]; | |
| directed_laplacian_matrix -> to_scipy_sparse_array [label=1]; | |
| directed_laplacian_matrix -> is_aperiodic [label=1]; | |
| number_weakly_connected_components -> weakly_connected_components [label=1]; | |
| parse_adjlist -> empty_graph [label=1]; | |
| connected_caveman_graph -> caveman_graph [label=1]; | |
| boykov_kolmogorov -> build_residual_network [label=1]; | |
| convert_node_labels_to_integers -> relabel_nodes [label=1]; | |
| threshold_graph -> empty_graph [label=1]; | |
| read_edgelist -> parse_edgelist [label=1]; | |
| bethe_hessian_matrix -> to_scipy_sparse_array [label=1]; | |
| node_disjoint_paths -> edge_disjoint_paths [label=1]; | |
| node_disjoint_paths -> build_auxiliary_node_connectivity [label=1]; | |
| modularity -> is_partition [label=1]; | |
| is_directed_acyclic_graph -> has_cycle [label=1]; | |
| vf2pp_is_isomorphic -> vf2pp_isomorphism [label=1]; | |
| geographical_threshold_graph -> empty_graph [label=1]; | |
| find_cycle -> edge_dfs [label=2]; | |
| sigma -> average_shortest_path_length [label=3]; | |
| sigma -> random_reference [label=2]; | |
| sigma -> transitivity [label=3]; | |
| newman_watts_strogatz_graph -> complete_graph [label=1]; | |
| newman_watts_strogatz_graph -> empty_graph [label=1]; | |
| local_edge_connectivity -> build_auxiliary_edge_connectivity [label=1]; | |
| local_edge_connectivity -> maximum_flow_value [label=1]; | |
| has_cycle -> topological_sort [label=1]; | |
| is_aperiodic -> is_aperiodic [label=1]; | |
| preflow_push -> detect_unboundedness [label=1]; | |
| preflow_push -> build_residual_network [label=1]; | |
| group_out_degree_centrality -> group_degree_centrality [label=1]; | |
| read_gexf -> from_dict_of_dicts [label=1]; | |
| read_gexf -> relabel_nodes [label=1]; | |
| prominent_group -> is_connected [label=1]; | |
| prominent_group -> is_strongly_connected [label=1]; | |
| threshold_accepting_tsp -> greedy_tsp [label=1]; | |
| hexagonal_lattice_graph -> contracted_nodes [label=25]; | |
| hexagonal_lattice_graph -> empty_graph [label=1]; | |
| eulerian_circuit -> is_eulerian [label=1]; | |
| all_simple_paths -> all_simple_edge_paths [label=1]; | |
| is_bipartite_node_set -> connected_components [label=1]; | |
| is_bipartite_node_set -> sets [label=2]; | |
| find_threshold_graph -> find_creation_sequence [label=1]; | |
| find_threshold_graph -> threshold_graph [label=1]; | |
| optimal_edit_paths -> optimize_edit_paths [label=1]; | |
| flow_hierarchy -> strongly_connected_components [label=1]; | |
| gnr_graph -> empty_graph [label=1]; | |
| dfs_successors -> dfs_edges [label=1]; | |
| union -> union_all [label=1]; | |
| stochastic_graph -> from_dict_of_dicts [label=1]; | |
| simulated_annealing_tsp -> greedy_tsp [label=1]; | |
| edge_expansion -> cut_size [label=1]; | |
| dodecahedral_graph -> LCF_graph [label=1]; | |
| laplacian_matrix -> to_scipy_sparse_array [label=1]; | |
| house_x_graph -> house_graph [label=1]; | |
| min_edge_cover -> eppstein_matching [label=1]; | |
| min_edge_cover -> number_of_isolates [label=1]; | |
| min_edge_cover -> hopcroft_karp_matching [label=1]; | |
| min_edge_cover -> max_weight_matching [label=1]; | |
| truncated_tetrahedron_graph -> path_graph [label=1]; | |
| bull_graph -> from_dict_of_lists [label=1]; | |
| ego_graph -> single_source_dijkstra [label=1]; | |
| ego_graph -> single_source_shortest_path_length [label=1]; | |
| k_clique_communities -> connected_components [label=1]; | |
| k_clique_communities -> find_cliques [label=1]; | |
| is_branching -> is_forest [label=1]; | |
| gnm_random_graph -> complete_graph [label=1]; | |
| k_factor -> is_perfect_matching [label=1]; | |
| k_factor -> max_weight_matching [label=1]; | |
| eulerian_path -> has_eulerian_path [label=2]; | |
| eulerian_path -> is_eulerian [label=2]; | |
| chordal_cycle_graph -> empty_graph [label=1]; | |
| normalized_laplacian_spectrum -> normalized_laplacian_matrix [label=1]; | |
| weighted_one_edge_augmentation -> collapse [label=1]; | |
| weighted_one_edge_augmentation -> connected_components [label=1]; | |
| weighted_one_edge_augmentation -> minimum_spanning_tree [label=1]; | |
| weighted_one_edge_augmentation -> is_connected [label=1]; | |
| thresholded_random_geometric_graph -> empty_graph [label=1]; | |
| random_labeled_tree -> from_prufer_sequence [label=1]; | |
| random_labeled_tree -> empty_graph [label=1]; | |
| bipartite_havel_hakimi_graph -> empty_graph [label=1]; | |
| paley_graph -> empty_graph [label=1]; | |
| complete_graph -> empty_graph [label=1]; | |
| heawood_graph -> LCF_graph [label=1]; | |
| asadpour_atsp -> eulerian_circuit [label=1]; | |
| asadpour_atsp -> held_karp_ascent [label=1]; | |
| asadpour_atsp -> from_dict_of_dicts [label=1]; | |
| asadpour_atsp -> min_cost_flow [label=1]; | |
| asadpour_atsp -> random_spanning_tree [label=4]; | |
| asadpour_atsp -> spanning_tree_distribution [label=1]; | |
| k_edge_subgraphs -> general_k_edge_subgraphs [label=1]; | |
| k_edge_subgraphs -> k_edge_components [label=1]; | |
| parse_graphml -> from_dict_of_dicts [label=1]; | |
| is_semieulerian -> has_eulerian_path [label=1]; | |
| is_semieulerian -> is_eulerian [label=1]; | |
| from_edgelist -> empty_graph [label=1]; | |
| directed_configuration_model -> empty_graph [label=1]; | |
| joint_degree_graph -> empty_graph [label=1]; | |
| joint_degree_graph -> is_valid_joint_degree [label=1]; | |
| disjoint_union -> disjoint_union_all [label=1]; | |
| floyd_warshall -> floyd_warshall_predecessor_and_distance [label=1]; | |
| bipartite_read_edgelist -> bipartite_parse_edgelist [label=1]; | |
| numeric_assortativity_coefficient -> attribute_mixing_matrix [label=1]; | |
| complete_bipartite_graph -> empty_graph [label=1]; | |
| dfs_preorder_nodes -> dfs_labeled_edges [label=1]; | |
| is_arborescence -> is_tree [label=1]; | |
| degree_mixing_dict -> node_degree_xy [label=1]; | |
| to_prufer_sequence -> is_tree [label=1]; | |
| gaussian_random_partition_graph -> random_partition_graph [label=1]; | |
| check_planarity_recursive -> get_counterexample_recursive [label=1]; | |
| is_weakly_connected -> weakly_connected_components [label=1]; | |
| latapy_clustering -> is_bipartite [label=1]; | |
| pad_graph -> complete_graph [label=1]; | |
| pad_graph -> relabel_nodes [label=1]; | |
| kernighan_lin_bisection -> is_partition [label=1]; | |
| bfs_edges -> generic_bfs_edges [label=1]; | |
| random_geometric_graph -> empty_graph [label=1]; | |
| full_join -> relabel_nodes [label=2]; | |
| full_join -> union [label=1]; | |
| dense_gnm_random_graph -> empty_graph [label=1]; | |
| is_strongly_regular -> is_distance_regular [label=1]; | |
| is_strongly_regular -> diameter [label=1]; | |
| line_graph -> empty_graph [label=1]; | |
| read_sparse6 -> from_sparse6_bytes [label=2]; | |
| google_matrix -> to_numpy_array [label=1]; | |
| maximum_spanning_edges -> kruskal_mst_edges [label=1]; | |
| maximum_spanning_edges -> boruvka_mst_edges [label=1]; | |
| maximum_spanning_edges -> prim_mst_edges [label=1]; | |
| grid_2d_graph -> empty_graph [label=1]; | |
| reverse_havel_hakimi_graph -> empty_graph [label=1]; | |
| unconstrained_bridge_augmentation -> bridge_components [label=1]; | |
| unconstrained_bridge_augmentation -> collapse [label=1]; | |
| unconstrained_bridge_augmentation -> connected_components [label=1]; | |
| unconstrained_bridge_augmentation -> dfs_preorder_nodes [label=1]; | |
| house_graph -> from_dict_of_lists [label=1]; | |
| gn_graph -> empty_graph [label=1]; | |
| read_pajek -> parse_pajek [label=1]; | |
| diamond_graph -> from_dict_of_lists [label=1]; | |
| spectral_bipartivity -> to_numpy_array [label=1]; | |
| communicability_betweenness_centrality -> to_numpy_array [label=1]; | |
| read_multiline_adjlist -> parse_multiline_adjlist [label=1]; | |
| treewidth_min_degree -> treewidth_decomp [label=1]; | |
| parse_multiline_adjlist -> empty_graph [label=1]; | |
| is_forest -> weakly_connected_components [label=1]; | |
| is_forest -> connected_components [label=1]; | |
| windmill_graph -> complete_graph [label=1]; | |
| windmill_graph -> disjoint_union_all [label=1]; | |
| single_source_dijkstra_path_length -> multi_source_dijkstra_path_length [label=1]; | |
| rich_club_coefficient -> double_edge_swap [label=1]; | |
| kl_connected_subgraph -> shortest_path [label=512]; | |
| tadpole_graph -> cycle_graph [label=1]; | |
| min_cost_flow_cost -> network_simplex [label=1]; | |
| intersection -> intersection_all [label=1]; | |
| moebius_kantor_graph -> LCF_graph [label=1]; | |
| dinitz -> build_residual_network [label=1]; | |
| tutte_graph -> from_dict_of_lists [label=1]; | |
| lollipop_graph -> complete_graph [label=1]; | |
| louvain_partitions -> modularity [label=4]; | |
| maximum_spanning_arborescence -> is_arborescence [label=1]; | |
| maximum_spanning_arborescence -> maximum_branching [label=1]; | |
| triad_type -> is_triad [label=1]; | |
| number_attracting_components -> attracting_components [label=1]; | |
| strategy_connected_sequential -> bfs_edges [label=2]; | |
| strategy_connected_sequential -> connected_components [label=1]; | |
| strategy_connected_sequential -> dfs_edges [label=2]; | |
| lowest_common_ancestor -> all_pairs_lowest_common_ancestor [label=1]; | |
| group_betweenness_centrality -> is_connected [label=2]; | |
| group_betweenness_centrality -> is_strongly_connected [label=1]; | |
| tournament_matrix -> adjacency_matrix [label=1]; | |
| to_nested_tuple -> is_tree [label=1]; | |
| spanning_tree_distribution -> contracted_edge [label=37]; | |
| spanning_tree_distribution -> total_spanning_tree_weight [label=74]; | |
| bipartite_min_edge_cover -> min_edge_cover [label=1]; | |
| hypercube_graph -> grid_graph [label=1]; | |
| truncated_cube_graph -> from_dict_of_lists [label=1]; | |
| cut_size -> edge_boundary [label=2]; | |
| star_graph -> empty_graph [label=1]; | |
| gnp_random_graph -> complete_graph [label=1]; | |
| minimum_spanning_tree -> minimum_spanning_edges [label=1]; | |
| spanner -> empty_graph [label=1]; | |
| bipartite_configuration_model -> empty_graph [label=1]; | |
| icosahedral_graph -> from_dict_of_lists [label=1]; | |
| circular_ladder_graph -> ladder_graph [label=1]; | |
| edge_current_flow_betweenness_centrality -> is_connected [label=1]; | |
| edge_current_flow_betweenness_centrality -> connected_components [label=1]; | |
| edge_current_flow_betweenness_centrality -> flow_matrix_row [label=1]; | |
| edge_current_flow_betweenness_centrality -> relabel_nodes [label=1]; | |
| edge_current_flow_betweenness_centrality -> shortest_path_length [label=2]; | |
| min_weight_matching -> max_weight_matching [label=1]; | |
| from_prufer_sequence -> empty_graph [label=1]; | |
| krackhardt_kite_graph -> from_dict_of_lists [label=1]; | |
| degree_mixing_matrix -> degree_mixing_dict [label=1]; | |
| stoer_wagner -> from_edgelist [label=2]; | |
| stoer_wagner -> is_connected [label=1]; | |
| stoer_wagner -> single_source_shortest_path_length [label=1]; | |
| laplacian_spectrum -> laplacian_matrix [label=1]; | |
| hnm_harary_graph -> empty_graph [label=1]; | |
| number_strongly_connected_components -> strongly_connected_components [label=1]; | |
| from_agraph -> empty_graph [label=1]; | |
| multi_source_dijkstra_path -> multi_source_dijkstra [label=1]; | |
| null_graph -> empty_graph [label=1]; | |
| could_be_isomorphic -> find_cliques [label=2]; | |
| could_be_isomorphic -> triangles [label=2]; | |
| random_degree_sequence_graph -> from_edgelist [label=2]; | |
| random_degree_sequence_graph -> is_graphical [label=1]; | |
| maximum_independent_set -> clique_removal [label=1]; | |
| number_of_nonisomorphic_trees -> nonisomorphic_trees [label=1]; | |
| bfs_tree -> bfs_edges [label=1]; | |
| number_connected_components -> connected_components [label=1]; | |
| max_clique -> clique_removal [label=1]; | |
| max_clique -> complement [label=1]; | |
| full_rary_tree -> empty_graph [label=1]; | |
| circulant_graph -> empty_graph [label=1]; | |
| cubical_graph -> from_dict_of_lists [label=1]; | |
| random_labeled_rooted_tree -> random_labeled_tree [label=1]; | |
| fast_could_be_isomorphic -> triangles [label=2]; | |
| total_spanning_tree_weight -> laplacian_matrix [label=1]; | |
| bellman_ford_path -> single_source_bellman_ford [label=1]; | |
| random_clustered_graph -> empty_graph [label=1]; | |
| common_neighbor_centrality -> shortest_path_length [label=1]; | |
| efficiency -> shortest_path_length [label=1]; | |
| path_graph -> empty_graph [label=1]; | |
| d_separated -> is_directed_acyclic_graph [label=1]; | |
| d_separated -> weakly_connected_components [label=1]; | |
| rooted_tree_isomorphism -> assign_levels [label=1]; | |
| rooted_tree_isomorphism -> is_tree [label=2]; | |
| rooted_tree_isomorphism -> root_trees [label=1]; | |
| assign_levels -> bfs_edges [label=1]; | |
| dfs_postorder_nodes -> dfs_labeled_edges [label=1]; | |
| random_partition_graph -> stochastic_block_model [label=1]; | |
| flow_matrix_row -> laplacian_matrix [label=1]; | |
| partition_spanning_tree -> kruskal_mst_edges [label=1]; | |
| inter_community_edges -> quotient_graph [label=1]; | |
| degree_pearson_correlation_coefficient -> node_degree_xy [label=1]; | |
| dorogovtsev_goltsev_mendes_graph -> empty_graph [label=1]; | |
| alternating_havel_hakimi_graph -> empty_graph [label=1]; | |
| dfs_tree -> dfs_edges [label=1]; | |
| edmonds_karp -> edmonds_karp_core [label=1]; | |
| edmonds_karp -> build_residual_network [label=1]; | |
| watts_strogatz_graph -> complete_graph [label=1]; | |
| minimum_spanning_arborescence -> is_arborescence [label=1]; | |
| minimum_spanning_arborescence -> minimal_branching [label=1]; | |
| min_maximal_matching -> maximal_matching [label=1]; | |
| onion_layers -> isolates [label=1]; | |
| mixing_expansion -> cut_size [label=1]; | |
| is_planar -> check_planarity [label=1]; | |
| desargues_graph -> LCF_graph [label=1]; | |
| local_and_global_consistency -> to_scipy_sparse_array [label=1]; | |
| hopcroft_karp_matching -> sets [label=1]; | |
| from_sparse6_bytes -> from_dict_of_dicts [label=1]; | |
| trophic_levels -> adjacency_matrix [label=1]; | |
| eppstein_matching -> sets [label=1]; | |
| eppstein_matching -> from_edgelist [label=1]; | |
| directed_joint_degree_graph -> is_valid_directed_joint_degree [label=1]; | |
| to_vertex_cover -> sets [label=1]; | |
| partial_duplication_graph -> complete_graph [label=1]; | |
| one_edge_augmentation -> weighted_one_edge_augmentation [label=1]; | |
| one_edge_augmentation -> unconstrained_one_edge_augmentation [label=1]; | |
| transitive_reduction -> dfs_edges [label=3]; | |
| transitive_reduction -> is_directed_acyclic_graph [label=1]; | |
| max_flow_min_cost -> from_dict_of_dicts [label=1]; | |
| max_flow_min_cost -> maximum_flow_value [label=1]; | |
| max_flow_min_cost -> min_cost_flow [label=1]; | |
| bipartite_betweenness_centrality -> betweenness_centrality [label=1]; | |
| simrank_similarity -> to_numpy_array [label=1]; | |
| minimal_branching -> maximum_branching [label=1]; | |
| single_source_dijkstra -> multi_source_dijkstra [label=1]; | |
| read_adjlist -> parse_adjlist [label=1]; | |
| bipartite_average_clustering -> latapy_clustering [label=1]; | |
| randomized_partitioning -> cut_size [label=1]; | |
| is_equitable -> is_coloring [label=1]; | |
| descendants -> bfs_edges [label=1]; | |
| preferential_attachment_graph -> empty_graph [label=1]; | |
| all_pairs_bellman_ford_path -> single_source_bellman_ford_path [label=7]; | |
| fiedler_vector -> is_connected [label=1]; | |
| fiedler_vector -> connected_components [label=1]; | |
| fiedler_vector -> laplacian_matrix [label=1]; | |
| fiedler_vector -> shortest_path_length [label=2]; | |
| is_attracting_component -> attracting_components [label=1]; | |
| random_graph -> from_dict_of_dicts [label=1]; | |
| parse_pajek -> from_dict_of_dicts [label=1]; | |
| communicability_exp -> to_numpy_array [label=1]; | |
| random_labeled_rooted_forest -> empty_graph [label=1]; | |
| petersen_graph -> from_dict_of_lists [label=1]; | |
| expected_degree_graph -> empty_graph [label=1]; | |
| vf2pp_isomorphism -> vf2pp_all_isomorphisms [label=1]; | |
| random_cograph -> disjoint_union [label=1]; | |
| random_cograph -> empty_graph [label=1]; | |
| random_cograph -> full_join [label=2]; | |
| random_cograph -> relabel_nodes [label=3]; | |
| generate_random_paths -> to_numpy_array [label=1]; | |
| barbell_graph -> complete_graph [label=1]; | |
| random_powerlaw_tree -> degree_sequence_tree [label=1]; | |
| random_powerlaw_tree -> random_powerlaw_tree_sequence [label=1]; | |
| to_pandas_adjacency -> to_numpy_array [label=1]; | |
| single_source_bellman_ford_path -> single_source_bellman_ford [label=1]; | |
| average_clustering -> clustering [label=1]; | |
| octahedral_graph -> from_dict_of_lists [label=1]; | |
| group_closeness_centrality -> multi_source_dijkstra_path_length [label=1]; | |
| chvatal_graph -> from_dict_of_lists [label=1]; | |
| chordal_graph_cliques -> connected_components [label=1]; | |
| subgraph_centrality_exp -> to_numpy_array [label=1]; | |
| graph_edit_distance -> optimize_edit_paths [label=1]; | |
| from_numpy_array -> empty_graph [label=1]; | |
| number_of_isolates -> isolates [label=1]; | |
| edge_current_flow_betweenness_centrality_subset -> connected_components [label=1]; | |
| edge_current_flow_betweenness_centrality_subset -> flow_matrix_row [label=1]; | |
| edge_current_flow_betweenness_centrality_subset -> is_connected [label=1]; | |
| edge_current_flow_betweenness_centrality_subset -> relabel_nodes [label=1]; | |
| edge_current_flow_betweenness_centrality_subset -> shortest_path_length [label=2]; | |
| bridge_components -> bridges [label=1]; | |
| bridge_components -> connected_components [label=1]; | |
| powerlaw_cluster_graph -> empty_graph [label=1]; | |
| strategy_connected_sequential_dfs -> strategy_connected_sequential [label=1]; | |
| is_bipartite -> color [label=1]; | |
| random_shell_graph -> convert_node_labels_to_integers [label=2]; | |
| random_shell_graph -> empty_graph [label=1]; | |
| random_shell_graph -> gnm_random_graph [label=2]; | |
| random_shell_graph -> union [label=2]; | |
| topological_sort -> topological_generations [label=1]; | |
| subgraph_centrality -> to_numpy_array [label=1]; | |
| from_biadjacency_matrix -> empty_graph [label=1]; | |
| random_uniform_k_out_graph -> empty_graph [label=1]; | |
| is_distance_regular -> intersection_array [label=1]; | |
| boundary_expansion -> node_boundary [label=1]; | |
| trophic_incoherence_parameter -> trophic_differences [label=1]; | |
| voronoi_cells -> multi_source_dijkstra_path [label=1]; | |
| attribute_mixing_matrix -> attribute_mixing_dict [label=1]; | |
| dijkstra_path -> single_source_dijkstra [label=1]; | |
| planted_partition_graph -> random_partition_graph [label=1]; | |
| dfs_predecessors -> dfs_edges [label=1]; | |
| treewidth_min_fill_in -> treewidth_decomp [label=1]; | |
| wheel_graph -> empty_graph [label=1]; | |
| } |
This file contains hidden or bidirectional Unicode text that may be interpreted or compiled differently than what appears below. To review, open the file in an editor that reveals hidden Unicode characters.
Learn more about bidirectional Unicode characters
| digraph { | |
| all_pairs_shortest_path_length; | |
| boruvka_mst_edges; | |
| greedy_k_edge_augmentation; | |
| closeness_centrality; | |
| condensation; | |
| average_node_connectivity; | |
| current_flow_betweenness_centrality; | |
| eccentricity; | |
| constraint; | |
| local_bridges; | |
| minimum_cycle_basis; | |
| girvan_newman; | |
| shortest_path_length; | |
| minimum_node_cut; | |
| disjoint_union_all; | |
| held_karp_ascent; | |
| local_efficiency; | |
| newman_betweenness_centrality; | |
| ramsey_R2; | |
| local_node_connectivity; | |
| wiener_index; | |
| effective_size; | |
| lattice_reference; | |
| all_pairs_node_connectivity; | |
| join_trees; | |
| sets; | |
| node_connectivity; | |
| minimum_edge_cut; | |
| minimum_st_node_cut; | |
| all_pairs_dijkstra; | |
| partial_k_edge_augmentation; | |
| all_node_cuts; | |
| get_counterexample_recursive; | |
| simple_cycles; | |
| spectral_ordering; | |
| global_efficiency; | |
| tournament_is_strongly_connected; | |
| normalized_mutual_weight; | |
| eulerize; | |
| is_eulerian; | |
| periphery; | |
| edge_connectivity; | |
| all_pairs_dijkstra_path_length; | |
| is_locally_k_edge_connected; | |
| ancestors; | |
| kosaraju_strongly_connected_components; | |
| random_reference; | |
| k_edge_components; | |
| shortest_path; | |
| omega; | |
| k_edge_augmentation; | |
| root_to_leaf_paths; | |
| all_pairs_shortest_path; | |
| is_reachable; | |
| transitive_closure_dag; | |
| transitive_closure; | |
| approximate_diameter; | |
| bridges; | |
| volume; | |
| girth; | |
| chordless_cycles; | |
| k_components; | |
| edge_boundary; | |
| tutte_polynomial; | |
| vf2pp_all_isomorphisms; | |
| contracted_edge; | |
| triangular_lattice_graph; | |
| clique_removal; | |
| diameter; | |
| k_core; | |
| read_graphml; | |
| mutual_weight; | |
| current_flow_betweenness_centrality_subset; | |
| get_counterexample; | |
| connected_double_edge_swap; | |
| chromatic_polynomial; | |
| algebraic_connectivity; | |
| all_pairs_dijkstra_path; | |
| minimal_d_separator; | |
| complete_to_chordal_graph; | |
| from_dict_of_dicts; | |
| is_minimal_d_separator; | |
| has_eulerian_path; | |
| has_path; | |
| biconnected_components; | |
| harmonic_centrality; | |
| random_unlabeled_tree; | |
| average_shortest_path_length; | |
| k_truss; | |
| grid_graph; | |
| minimum_st_edge_cut; | |
| union_all; | |
| bipartite_closeness_centrality; | |
| closeness_vitality; | |
| descendants_at_distance; | |
| lukes_partitioning; | |
| normalized_cut_size; | |
| random_spanning_tree; | |
| from_nested_tuple; | |
| approximate_all_pairs_node_connectivity; | |
| center; | |
| minimum_cut; | |
| relabel_nodes; | |
| conductance; | |
| all_pairs_lowest_common_ancestor; | |
| random_unlabeled_rooted_forest; | |
| check_planarity; | |
| all_pairs_bellman_ford_path_length; | |
| incremental_closeness_centrality; | |
| naive_greedy_modularity_communities; | |
| local_reaching_centrality; | |
| isolates; | |
| minimum_spanning_edges; | |
| is_tree; | |
| predecessor; | |
| root_trees; | |
| antichains; | |
| gomory_hu_tree; | |
| general_k_edge_subgraphs; | |
| approximate_node_connectivity; | |
| read_graph6; | |
| is_k_edge_connected; | |
| radius; | |
| create_component_structure; | |
| approximate_current_flow_betweenness_centrality; | |
| approximate_k_components; | |
| is_kl_connected; | |
| configuration_model; | |
| node_clique_number; | |
| tree_isomorphism; | |
| recursive_simple_cycles; | |
| local_constraint; | |
| maximum_branching; | |
| random_unlabeled_rooted_tree; | |
| current_flow_closeness_centrality; | |
| global_reaching_centrality; | |
| triads_by_type; | |
| single_source_dijkstra_path; | |
| all_pairs_all_shortest_paths; | |
| steiner_tree; | |
| single_source_all_shortest_paths; | |
| one_exchange; | |
| cycle_graph; | |
| edge_load_centrality; | |
| edge_betweenness_centrality; | |
| convert_node_labels_to_integers; | |
| dfs_edges; | |
| modularity; | |
| edge_bfs; | |
| find_cycle; | |
| sigma; | |
| local_edge_connectivity; | |
| hexagonal_lattice_graph; | |
| empty_graph; | |
| all_simple_paths; | |
| is_bipartite_node_set; | |
| union; | |
| laplacian_matrix; | |
| ego_graph; | |
| gnm_random_graph; | |
| eulerian_path; | |
| complete_graph; | |
| asadpour_atsp; | |
| from_edgelist; | |
| dfs_preorder_nodes; | |
| check_planarity_recursive; | |
| is_weakly_connected; | |
| bfs_layers; | |
| bfs_edges; | |
| full_join; | |
| read_sparse6; | |
| single_source_dijkstra_path_length; | |
| kl_connected_subgraph; | |
| louvain_partitions; | |
| triad_type; | |
| strategy_connected_sequential; | |
| group_betweenness_centrality; | |
| spanning_tree_distribution; | |
| is_connected; | |
| strongly_connected_components; | |
| cut_size; | |
| edge_current_flow_betweenness_centrality; | |
| stoer_wagner; | |
| dijkstra_predecessor_and_distance; | |
| could_be_isomorphic; | |
| random_degree_sequence_graph; | |
| number_connected_components; | |
| fast_could_be_isomorphic; | |
| total_spanning_tree_weight; | |
| path_graph; | |
| rooted_tree_isomorphism; | |
| single_source_shortest_path_length; | |
| single_source_shortest_path; | |
| triangles; | |
| edge_dfs; | |
| edmonds_karp; | |
| minimum_spanning_arborescence; | |
| transitivity; | |
| bfs_labeled_edges; | |
| from_sparse6_bytes; | |
| transitive_reduction; | |
| dominating_set; | |
| contracted_nodes; | |
| single_source_dijkstra; | |
| from_graph6_bytes; | |
| descendants; | |
| single_source_bellman_ford_path_length; | |
| all_pairs_bellman_ford_path; | |
| fiedler_vector; | |
| cartesian_product; | |
| connected_components; | |
| core_number; | |
| find_cliques; | |
| random_cograph; | |
| approximate_local_node_connectivity; | |
| single_source_bellman_ford_path; | |
| average_clustering; | |
| edge_current_flow_betweenness_centrality_subset; | |
| is_simple_path; | |
| random_shell_graph; | |
| all_pairs_shortest_path_length -> single_source_shortest_path_length [label=75]; | |
| boruvka_mst_edges -> edge_boundary [label=21]; | |
| greedy_k_edge_augmentation -> is_k_edge_connected [label=22]; | |
| greedy_k_edge_augmentation -> is_locally_k_edge_connected [label=116]; | |
| closeness_centrality -> single_source_shortest_path_length [label=100]; | |
| closeness_centrality -> single_source_dijkstra_path_length [label=5]; | |
| average_node_connectivity -> local_node_connectivity [label=12]; | |
| current_flow_betweenness_centrality -> shortest_path_length [label=3]; | |
| eccentricity -> shortest_path_length [label=50]; | |
| constraint -> local_constraint [label=20]; | |
| local_bridges -> shortest_path_length [label=9]; | |
| minimum_cycle_basis -> minimum_spanning_edges [label=3]; | |
| minimum_cycle_basis -> shortest_path [label=21]; | |
| minimum_cycle_basis -> shortest_path_length [label=168]; | |
| girvan_newman -> connected_components [label=22]; | |
| girvan_newman -> edge_betweenness_centrality [label=22]; | |
| girvan_newman -> number_connected_components [label=10]; | |
| minimum_node_cut -> minimum_st_node_cut [label=98]; | |
| disjoint_union_all -> complete_graph [label=16]; | |
| held_karp_ascent -> is_weakly_connected [label=120]; | |
| held_karp_ascent -> minimum_spanning_arborescence [label=2100]; | |
| local_efficiency -> global_efficiency [label=9]; | |
| newman_betweenness_centrality -> predecessor [label=77]; | |
| newman_betweenness_centrality -> dijkstra_predecessor_and_distance [label=6]; | |
| ramsey_R2 -> ramsey_R2 [label=2]; | |
| effective_size -> normalized_mutual_weight [label=148]; | |
| effective_size -> ego_graph [label=7]; | |
| lattice_reference -> local_edge_connectivity [label=184]; | |
| all_pairs_node_connectivity -> local_node_connectivity [label=190]; | |
| join_trees -> convert_node_labels_to_integers [label=2]; | |
| node_connectivity -> local_node_connectivity [label=100]; | |
| minimum_edge_cut -> dominating_set [label=5]; | |
| minimum_edge_cut -> minimum_st_edge_cut [label=34]; | |
| all_pairs_dijkstra -> single_source_dijkstra [label=15]; | |
| partial_k_edge_augmentation -> k_edge_augmentation [label=5]; | |
| all_node_cuts -> antichains [label=37]; | |
| all_node_cuts -> condensation [label=37]; | |
| all_node_cuts -> edmonds_karp [label=247]; | |
| all_node_cuts -> is_connected [label=2]; | |
| all_node_cuts -> transitive_closure [label=37]; | |
| get_counterexample_recursive -> check_planarity_recursive [label=29]; | |
| simple_cycles -> strongly_connected_components [label=11]; | |
| simple_cycles -> biconnected_components [label=46]; | |
| spectral_ordering -> connected_components [label=3]; | |
| spectral_ordering -> laplacian_matrix [label=2]; | |
| spectral_ordering -> shortest_path_length [label=4]; | |
| tournament_is_strongly_connected -> is_reachable [label=16]; | |
| normalized_mutual_weight -> mutual_weight [label=7]; | |
| eulerize -> shortest_path [label=45]; | |
| periphery -> shortest_path_length [label=7]; | |
| edge_connectivity -> local_edge_connectivity [label=34]; | |
| edge_connectivity -> dominating_set [label=15]; | |
| all_pairs_dijkstra_path_length -> single_source_dijkstra_path_length [label=25]; | |
| kosaraju_strongly_connected_components -> dfs_preorder_nodes [label=10]; | |
| random_reference -> local_edge_connectivity [label=735]; | |
| k_edge_components -> minimum_cut [label=11]; | |
| omega -> average_clustering [label=12]; | |
| omega -> average_shortest_path_length [label=11]; | |
| omega -> lattice_reference [label=10]; | |
| omega -> random_reference [label=10]; | |
| root_to_leaf_paths -> all_simple_paths [label=16]; | |
| all_pairs_shortest_path -> single_source_shortest_path [label=16]; | |
| is_reachable -> is_simple_path [label=450]; | |
| transitive_closure_dag -> descendants_at_distance [label=29]; | |
| transitive_closure -> edge_bfs [label=202]; | |
| transitive_closure -> descendants [label=4]; | |
| approximate_diameter -> eccentricity [label=2]; | |
| approximate_diameter -> shortest_path_length [label=2]; | |
| girth -> bfs_labeled_edges [label=46]; | |
| chordless_cycles -> biconnected_components [label=500]; | |
| chordless_cycles -> strongly_connected_components [label=42]; | |
| k_components -> all_node_cuts [label=6]; | |
| k_components -> connected_components [label=17]; | |
| k_components -> node_connectivity [label=6]; | |
| tutte_polynomial -> bridges [label=511]; | |
| tutte_polynomial -> contracted_edge [label=255]; | |
| vf2pp_all_isomorphisms -> bfs_layers [label=10]; | |
| triangular_lattice_graph -> contracted_nodes [label=10]; | |
| clique_removal -> ramsey_R2 [label=31]; | |
| diameter -> shortest_path_length [label=4]; | |
| read_graphml -> from_dict_of_dicts [label=4]; | |
| current_flow_betweenness_centrality_subset -> shortest_path_length [label=3]; | |
| get_counterexample -> check_planarity [label=29]; | |
| connected_double_edge_swap -> is_connected [label=21]; | |
| connected_double_edge_swap -> has_path [label=31]; | |
| chromatic_polynomial -> contracted_edge [label=4095]; | |
| algebraic_connectivity -> shortest_path_length [label=2]; | |
| all_pairs_dijkstra_path -> single_source_dijkstra_path [label=16]; | |
| minimal_d_separator -> ancestors [label=2]; | |
| complete_to_chordal_graph -> has_path [label=714]; | |
| is_minimal_d_separator -> ancestors [label=2]; | |
| harmonic_centrality -> shortest_path_length [label=7]; | |
| random_unlabeled_tree -> empty_graph [label=10]; | |
| average_shortest_path_length -> single_source_shortest_path_length [label=50]; | |
| average_shortest_path_length -> single_source_dijkstra_path_length [label=7]; | |
| average_shortest_path_length -> single_source_bellman_ford_path_length [label=7]; | |
| k_truss -> isolates [label=3]; | |
| grid_graph -> cartesian_product [label=8]; | |
| grid_graph -> path_graph [label=9]; | |
| grid_graph -> cycle_graph [label=3]; | |
| union_all -> relabel_nodes [label=3]; | |
| union_all -> convert_node_labels_to_integers [label=17]; | |
| bipartite_closeness_centrality -> single_source_shortest_path_length [label=32]; | |
| closeness_vitality -> wiener_index [label=2]; | |
| closeness_vitality -> closeness_vitality [label=3]; | |
| lukes_partitioning -> descendants [label=64]; | |
| normalized_cut_size -> volume [label=2]; | |
| random_spanning_tree -> contracted_edge [label=80]; | |
| random_spanning_tree -> contracted_nodes [label=19]; | |
| random_spanning_tree -> from_dict_of_dicts [label=9]; | |
| random_spanning_tree -> total_spanning_tree_weight [label=88]; | |
| from_nested_tuple -> empty_graph [label=4]; | |
| from_nested_tuple -> join_trees [label=3]; | |
| approximate_all_pairs_node_connectivity -> approximate_local_node_connectivity [label=190]; | |
| center -> shortest_path_length [label=7]; | |
| conductance -> volume [label=2]; | |
| all_pairs_lowest_common_ancestor -> ancestors [label=11]; | |
| random_unlabeled_rooted_forest -> empty_graph [label=10]; | |
| all_pairs_bellman_ford_path_length -> single_source_bellman_ford_path_length [label=7]; | |
| incremental_closeness_centrality -> single_source_shortest_path_length [label=5]; | |
| naive_greedy_modularity_communities -> modularity [label=6545]; | |
| root_trees -> bfs_edges [label=2]; | |
| gomory_hu_tree -> minimum_cut [label=33]; | |
| general_k_edge_subgraphs -> connected_components [label=4]; | |
| general_k_edge_subgraphs -> minimum_edge_cut [label=8]; | |
| approximate_node_connectivity -> approximate_local_node_connectivity [label=19]; | |
| read_graph6 -> from_graph6_bytes [label=4]; | |
| radius -> shortest_path_length [label=7]; | |
| create_component_structure -> connected_components [label=15]; | |
| approximate_current_flow_betweenness_centrality -> shortest_path_length [label=3]; | |
| approximate_k_components -> approximate_local_node_connectivity [label=5130]; | |
| approximate_k_components -> biconnected_components [label=28]; | |
| approximate_k_components -> core_number [label=35]; | |
| approximate_k_components -> k_core [label=35]; | |
| is_kl_connected -> shortest_path [label=256]; | |
| configuration_model -> empty_graph [label=2]; | |
| node_clique_number -> find_cliques [label=2]; | |
| node_clique_number -> ego_graph [label=2]; | |
| tree_isomorphism -> center [label=2]; | |
| tree_isomorphism -> is_tree [label=2]; | |
| tree_isomorphism -> rooted_tree_isomorphism [label=2]; | |
| recursive_simple_cycles -> strongly_connected_components [label=30]; | |
| local_constraint -> normalized_mutual_weight [label=13]; | |
| maximum_branching -> shortest_path [label=8]; | |
| random_unlabeled_rooted_tree -> empty_graph [label=10]; | |
| current_flow_closeness_centrality -> shortest_path_length [label=3]; | |
| global_reaching_centrality -> local_reaching_centrality [label=5]; | |
| triads_by_type -> triad_type [label=120]; | |
| all_pairs_all_shortest_paths -> single_source_all_shortest_paths [label=5]; | |
| steiner_tree -> minimum_spanning_edges [label=2]; | |
| steiner_tree -> shortest_path [label=8]; | |
| one_exchange -> cut_size [label=19]; | |
| edge_load_centrality -> predecessor [label=7]; | |
| find_cycle -> edge_dfs [label=2]; | |
| sigma -> average_shortest_path_length [label=3]; | |
| sigma -> random_reference [label=2]; | |
| sigma -> transitivity [label=3]; | |
| hexagonal_lattice_graph -> contracted_nodes [label=25]; | |
| is_bipartite_node_set -> sets [label=2]; | |
| eulerian_path -> has_eulerian_path [label=2]; | |
| eulerian_path -> is_eulerian [label=2]; | |
| asadpour_atsp -> random_spanning_tree [label=4]; | |
| full_join -> relabel_nodes [label=2]; | |
| read_sparse6 -> from_sparse6_bytes [label=2]; | |
| kl_connected_subgraph -> shortest_path [label=512]; | |
| louvain_partitions -> modularity [label=4]; | |
| strategy_connected_sequential -> bfs_edges [label=2]; | |
| strategy_connected_sequential -> dfs_edges [label=2]; | |
| group_betweenness_centrality -> is_connected [label=2]; | |
| spanning_tree_distribution -> contracted_edge [label=37]; | |
| spanning_tree_distribution -> total_spanning_tree_weight [label=74]; | |
| cut_size -> edge_boundary [label=2]; | |
| edge_current_flow_betweenness_centrality -> shortest_path_length [label=2]; | |
| stoer_wagner -> from_edgelist [label=2]; | |
| could_be_isomorphic -> find_cliques [label=2]; | |
| could_be_isomorphic -> triangles [label=2]; | |
| random_degree_sequence_graph -> from_edgelist [label=2]; | |
| fast_could_be_isomorphic -> triangles [label=2]; | |
| rooted_tree_isomorphism -> is_tree [label=2]; | |
| transitive_reduction -> dfs_edges [label=3]; | |
| all_pairs_bellman_ford_path -> single_source_bellman_ford_path [label=7]; | |
| fiedler_vector -> shortest_path_length [label=2]; | |
| random_cograph -> full_join [label=2]; | |
| random_cograph -> relabel_nodes [label=3]; | |
| edge_current_flow_betweenness_centrality_subset -> shortest_path_length [label=2]; | |
| random_shell_graph -> convert_node_labels_to_integers [label=2]; | |
| random_shell_graph -> gnm_random_graph [label=2]; | |
| random_shell_graph -> union [label=2]; | |
| } |
This file contains hidden or bidirectional Unicode text that may be interpreted or compiled differently than what appears below. To review, open the file in an editor that reveals hidden Unicode characters.
Learn more about bidirectional Unicode characters
| diff --git a/networkx/utils/backends.py b/networkx/utils/backends.py | |
| index 4ecd1b13b..ce3578741 100644 | |
| --- a/networkx/utils/backends.py | |
| +++ b/networkx/utils/backends.py | |
| @@ -98,6 +98,16 @@ from ..exception import NetworkXNotImplemented | |
| __all__ = ["_dispatch"] | |
| +INDENT = "" | |
| +funclog = open("functions.log", "w") | |
| + | |
| +def is_iterator(x): | |
| + try: | |
| + return iter(x) is x | |
| + except Exception: | |
| + return False | |
| + | |
| + | |
| def _get_backends(group, *, load_and_call=False): | |
| items = entry_points(group=group) | |
| rv = {} | |
| @@ -403,6 +413,33 @@ class _dispatch: | |
| return self._sig | |
| def __call__(self, /, *args, backend=None, **kwargs): | |
| + global INDENT | |
| + funclog.write(f'{INDENT}{self.name}\n') | |
| + INDENT = INDENT + " " | |
| + try: | |
| + rv = self._call_(*args, backend=backend, **kwargs) | |
| + if self.name in { | |
| + # This is buggy: https://github.com/networkx/networkx/issues/7153 | |
| + "strategy_saturation_largest_first", | |
| + }: | |
| + return rv | |
| + if is_iterator(rv): | |
| + rv2 = [] | |
| + try: | |
| + for x in rv: | |
| + rv2.append(x) | |
| + except Exception as exc: | |
| + def will_raise(exc=exc): | |
| + yield from rv2 | |
| + raise exc | |
| + rv = will_raise() | |
| + else: | |
| + rv = (x for x in rv2) | |
| + return rv | |
| + finally: | |
| + INDENT = INDENT[:-1] | |
| + | |
| + def _call_(self, /, *args, backend=None, **kwargs): | |
| if not backends: | |
| # Fast path if no backends are installed | |
| return self.orig_func(*args, **kwargs) |
This file contains hidden or bidirectional Unicode text that may be interpreted or compiled differently than what appears below. To review, open the file in an editor that reveals hidden Unicode characters.
Learn more about bidirectional Unicode characters
| from collections import defaultdict | |
| with open("functions.log") as f: | |
| lines = f.readlines() | |
| lines = [line.rstrip() for line in lines] | |
| results = set() | |
| stack = [] | |
| for name in lines: | |
| indent = len(name) - len(name.lstrip()) | |
| name = name.lstrip() | |
| while len(stack) > indent: | |
| prev_name, prev = stack.pop() | |
| results.add((prev_name, tuple(sorted(prev.items())))) | |
| if stack: | |
| stack[-1][1][name] += 1 | |
| stack.append((name, defaultdict(int))) | |
| while stack: | |
| prev_name, prev = stack.pop() | |
| results.add((prev_name, tuple(sorted(prev.items())))) | |
| d = defaultdict(lambda: defaultdict(int)) | |
| for name, info in results: | |
| info = dict(info) | |
| cur = d[name] | |
| for key, val in info.items(): | |
| cur[key] = max(val, cur[key]) | |
| import networkx as nx | |
| edge_dicts = {k1: {k2: {"label": v2} for k2, v2 in v1.items()} for k1, v1 in d.items()} | |
| G1 = nx.from_dict_of_dicts(edge_dicts, create_using=nx.DiGraph) | |
| G1.remove_nodes_from(list(nx.isolates(G1))) | |
| nx.drawing.nx_pydot.write_dot(G1, "G1.dot") | |
| # $ dot -Tpng -Grankdir="LR" -Granksep=10 -o G1.png G1.dot | |
| G2 = nx.DiGraph( | |
| nx.subgraph_view(G1, filter_edge=lambda *edge: G1.edges[edge]["label"] > 1) | |
| ) | |
| G2.remove_nodes_from(list(nx.isolates(G2))) | |
| nx.drawing.nx_pydot.write_dot(G2, "G2.dot") | |
| # $ dot -Tpng -Grankdir="LR" -Granksep=1 -o G2.png G2.dot |
Sign up for free
to join this conversation on GitHub.
Already have an account?
Sign in to comment