aaa-igraph-package | The igraph package |
add_edges | Add edges to a graph |
add.edges | Add edges to a graph |
add_layout_ | Add layout to graph |
add.vertex.shape | Various vertex shapes when plotting igraph graphs |
add_vertices | Add vertices to a graph |
add.vertices | Add vertices to a graph |
adjacent.triangles | Find triangles in graphs |
adjacent_vertices | Adjacent vertices of multiple vertices in a graph |
aging.ba.game | Generate an evolving random graph with preferential... |
aging.barabasi.game | Generate an evolving random graph with preferential... |
aging.prefatt.game | Generate an evolving random graph with preferential... |
all_simple_paths | List all simple paths from one source |
alpha_centrality | Find Bonacich alpha centrality scores of network positions |
alpha.centrality | Find Bonacich alpha centrality scores of network positions |
are_adjacent | Are two vertices adjacent? |
are.connected | Are two vertices adjacent? |
arpack | ARPACK eigenvector calculation |
articulation_points | Articulation points and bridges of a graph |
articulation.points | Articulation points and bridges of a graph |
as_adj | Convert a graph to an adjacency matrix |
as_adjacency_matrix | Convert a graph to an adjacency matrix |
as_adj_list | Adjacency lists |
as_biadjacency_matrix | Bipartite adjacency matrix of a bipartite graph |
as_directed | Convert between directed and undirected graphs |
as.directed | Convert between directed and undirected graphs |
as_edgelist | Convert a graph to an edge list |
as_graphnel | Convert igraph graphs to graphNEL objects from the graph... |
as_ids | Convert a vertex or edge sequence to an ordinary vector |
as.igraph | Conversion to igraph |
as_incidence_matrix | As incidence matrix |
as_long_data_frame | Convert a graph to a long data frame |
as.matrix.igraph | Convert igraph objects to adjacency or edge list matrices |
as_membership | Declare a numeric vector as a membership vector |
as_phylo | as_phylo |
assortativity | Assortativity coefficient |
assortativity.degree | Assortativity coefficient |
assortativity.nominal | Assortativity coefficient |
as.undirected | Convert between undirected and unundirected graphs |
asymmetric.preference.game | Trait-based random generation |
authority.score | Kleinberg's hub and authority centrality scores. |
autocurve.edges | Optimal edge curvature when plotting graphs |
automorphism_group | Generating set of the automorphism group of a graph |
automorphisms | Number of automorphisms |
average.path.length | Shortest (directed or undirected) paths between vertices |
ba.game | Generate random graphs using preferential attachment |
barabasi.game | Generate random graphs using preferential attachment |
betweenness | Vertex and edge betweenness centrality |
bfs | Breadth-first search |
biconnected_components | Biconnected components |
biconnected.components | Biconnected components |
bipartite_mapping | Decide whether a graph is bipartite |
bipartite.mapping | Decide whether a graph is bipartite |
bipartite_projection | Project a bipartite graph |
bipartite.projection | Project a bipartite graph |
bipartite.projection.size | Project a bipartite graph |
bipartite.random.game | Bipartite random graphs |
blockGraphs | Calculate Cohesive Blocks |
bonpow | Find Bonacich Power Centrality Scores of Network Positions |
callaway.traits.game | Graph generation based on different vertex types |
canonical_permutation | Canonical permutation of a graph |
canonical.permutation | Canonical permutation of a graph |
categorical_pal | Palette for categories |
centralization.betweenness | Centralize a graph according to the betweenness of vertices |
centralization.betweenness.tmax | Theoretical maximum for betweenness centralization |
centralization.closeness | Centralize a graph according to the closeness of vertices |
centralization.closeness.tmax | Theoretical maximum for closeness centralization |
centralization.degree | Centralize a graph according to the degrees of vertices |
centralization.degree.tmax | Theoretical maximum for degree centralization |
centralization.evcent | Centralize a graph according to the eigenvector centrality of... |
centralization.evcent.tmax | Theoretical maximum for betweenness centralization |
centralize | Centralization of a graph |
centralize.scores | Centralization of a graph |
centr_betw | Centralize a graph according to the betweenness of vertices |
centr_betw_tmax | Theoretical maximum for betweenness centralization |
centr_clo | Centralize a graph according to the closeness of vertices |
centr_clo_tmax | Theoretical maximum for closeness centralization |
centr_degree | Centralize a graph according to the degrees of vertices |
centr_degree_tmax | Theoretical maximum for degree centralization |
centr_eigen | Centralize a graph according to the eigenvector centrality of... |
centr_eigen_tmax | Theoretical maximum for eigenvector centralization |
c.igraph.es | Concatenate edge sequences |
c.igraph.vs | Concatenate vertex sequences |
cited.type.game | Random citation graphs |
citing.cited.type.game | Random citation graphs |
clique.number | Functions to find cliques, i.e. complete subgraphs in a graph |
cliques | Functions to find cliques, i.e. complete subgraphs in a graph |
closeness | Closeness centrality of vertices |
cluster.distribution | Connected components of a graph |
cluster_edge_betweenness | Community structure detection based on edge betweenness |
cluster_fast_greedy | Community structure via greedy optimization of modularity |
cluster_fluid_communities | Community detection algorithm based on interacting fluids |
cluster_infomap | Infomap community finding |
cluster_label_prop | Finding communities based on propagating labels |
cluster_leading_eigen | Community structure detecting based on the leading... |
cluster_leiden | Finding community structure of a graph using the Leiden... |
cluster_louvain | Finding community structure by multi-level optimization of... |
cluster_optimal | Optimal community structure |
clusters | Connected components of a graph |
cluster_spinglass | Finding communities in graphs based on statistical meachanics |
cluster_walktrap | Community structure via short random walks |
cocitation | Cocitation coupling |
code.length | Functions to deal with the result of network community... |
cohesive_blocks | Calculate Cohesive Blocks |
cohesive.blocks | Calculate Cohesive Blocks |
communities | Functions to deal with the result of network community... |
compare | Compares community structures using various metrics |
complementer | Complementer of a graph |
components | Connected components of a graph |
component_wise | Component-wise layout |
compose | Compose two graphs as binary relations |
connect.neighborhood | Neighborhood of graph vertices |
consensus_tree | Create a consensus tree from several hierarchical random... |
console | The igraph console |
constraint | Burt's constraint |
contract | Contract several vertices into a single one |
contract.vertices | Contract several vertices into a single one |
convex_hull | Convex hull of a set of vertices |
convex.hull | Convex hull of a set of vertices |
coreness | K-core decomposition of graphs |
count_automorphisms | Number of automorphisms |
count_isomorphisms | Count the number of isomorphic mappings between two graphs |
count_motifs | Graph motifs |
count.multiple | Find the multiple or loop edges in a graph |
count_subgraph_isomorphisms | Count the isomorphic mappings between a graph and the... |
count_triangles | Find triangles in graphs |
create.communities | Creates a communities object. |
curve_multiple | Optimal edge curvature when plotting graphs |
cutat | Functions to deal with the result of network community... |
decompose | Decompose a graph into components |
decompose.graph | Decompose a graph into components |
degree | Degree and degree distribution of the vertices |
degree.distribution | Degree and degree distribution of the vertices |
degree.sequence.game | Generate random graphs with a given degree sequence |
delete_edge_attr | Delete an edge attribute |
delete_edges | Delete edges from a graph |
delete.edges | Delete edges from a graph |
delete_graph_attr | Delete a graph attribute |
delete_vertex_attr | Delete a vertex attribute |
delete_vertices | Delete vertices from a graph |
delete.vertices | Delete vertices from a graph |
dendPlot | Community structure dendrogram plots |
dfs | Depth-first search |
diameter | Diameter of a graph |
difference | Difference of two sets |
difference.igraph | Difference of graphs |
difference.igraph.es | Difference of edge sequences |
difference.igraph.vs | Difference of vertex sequences |
dim_select | Dimensionality selection for singular values using profile... |
disjoint_union | Disjoint union of graphs |
distances | Shortest (directed or undirected) paths between vertices |
diverging_pal | Diverging palette |
diversity | Graph diversity |
dominator_tree | Dominator tree |
dominator.tree | Dominator tree |
dot-data | '.data' and '.env' pronouns |
dyad_census | Dyad census of a graph |
dyad.census | Dyad census of a graph |
E | Edges of a graph |
each_edge | Rewires the endpoints of the edges of a graph to a random... |
eccentricity | Eccentricity of the vertices in a graph |
edge | Helper function for adding and deleting edges |
edge_attr | Query edge attributes of a graph |
edge_attr_names | List names of edge attributes |
edge_attr-set | Set one or more edge attributes |
edge.betweenness | Vertex and edge betweenness centrality |
edge.betweenness.community | Community structure detection based on edge betweenness |
edge_connectivity | Edge connectivity |
edge.connectivity | Edge connectivity |
edge_density | Graph density |
edge.disjoint.paths | Edge connectivity |
ego | Neighborhood of graph vertices |
eigen_centrality | Eigenvector centrality of vertices |
embed_adjacency_matrix | Spectral Embedding of Adjacency Matrices |
embed_laplacian_matrix | Spectral Embedding of the Laplacian of a Graph |
ends | Incident vertices of some graph edges |
erdos.renyi.game | Generate random graphs according to the Erdős-Rényi model |
establishment.game | Graph generation based on different vertex types |
estimate_betweenness | Deprecated version of 'betweenness()' |
estimate_closeness | Deprecated version of 'closeness()' |
estimate_edge_betweenness | Deprecated version of 'edge_betweenness()' |
evcent | Find Eigenvector Centrality Scores of Network Positions |
exportPajek | Calculate Cohesive Blocks |
farthest.nodes | Diameter of a graph |
fastgreedy.community | Community structure via greedy optimization of modularity |
feedback_arc_set | Finding a feedback arc set in a graph |
fit_hrg | Fit a hierarchical random graph model |
fit_power_law | Fitting a power-law distribution function to discrete data |
forest.fire.game | Forest Fire Network Model |
from_incidence_matrix | Graph from incidence matrix |
get.adjacency | Convert a graph to an adjacency matrix |
get.adjedgelist | Adjacency lists |
get.adjlist | Adjacency lists |
get.all.shortest.paths | Shortest (directed or undirected) paths between vertices |
get.data.frame | Creating igraph graphs from data frames or vice-versa |
get.diameter | Diameter of a graph |
get.edge | Incident vertices of some graph edges |
get.edge.attribute | Query edge attributes of a graph |
get_edge_ids | Find the edge ids based on the incident vertices of the edges |
get.edge.ids | Find the edge ids based on the incident vertices of the edges |
get.edgelist | Convert a graph to an edge list |
get.graph.attribute | Graph attributes of a graph |
getIgraphOpt | Parameters for the igraph package |
get.incidence | Bipartite adjacency matrix of a bipartite graph |
get.shortest.paths | Shortest (directed or undirected) paths between vertices |
get.stochastic | Stochastic matrix of a graph |
get.vertex.attribute | Query vertex attributes of a graph |
girth | Girth of a graph |
global_efficiency | Efficiency of a graph |
gorder | Order (number of vertices) of a graph |
graph | Create an igraph graph from a list of edges, or a notable... |
graph_ | Convert object to a graph |
graph.adhesion | Edge connectivity |
graph.adjacency | Create graphs from adjacency matrices |
graph.adjlist | Create graphs from adjacency lists |
graph.atlas | Create a graph from the Graph Atlas |
graph_attr | Graph attributes of a graph |
graph_attr_names | List names of graph attributes |
graph_attr-set | Set all or some graph attributes |
graph.automorphisms | Number of automorphisms |
graph.bfs | Breadth-first search |
graph.bipartite | Create a bipartite graph |
graph_center | Central vertices of a graph |
graph.cohesion | Vertex connectivity |
graph.complementer | Complementer of a graph |
graph.compose | Compose two graphs as binary relations |
graph.coreness | K-core decomposition of graphs |
graph.data.frame | Creating igraph graphs from data frames or vice-versa |
graph.de.bruijn | De Bruijn graphs |
graph.density | Graph density |
graph.dfs | Depth-first search |
graph.difference | Difference of two sets |
graph.disjoint.union | Disjoint union of graphs |
graph.diversity | Graph diversity |
graph.edgelist | Create a graph from an edge list matrix |
graph.eigen | Eigenvalues and eigenvectors of the adjacency matrix of a... |
graph.empty | A graph with no edges |
graph.extended.chordal.ring | Create an extended chordal ring graph |
graph.famous | Create an igraph graph from a list of edges, or a notable... |
graph.formula | Creating (small) graphs via a simple interface |
graph_from_adjacency_matrix | Create graphs from adjacency matrices |
graph_from_adj_list | Create graphs from adjacency lists |
graph_from_atlas | Create a graph from the Graph Atlas |
graph_from_biadjacency_matrix | Create graphs from a bipartite adjacency matrix |
graph_from_data_frame | Creating igraph graphs from data frames or vice-versa |
graph_from_edgelist | Create a graph from an edge list matrix |
graph_from_graphdb | Load a graph from the graph database for testing graph... |
graph_from_graphnel | Convert graphNEL objects from the graph package to igraph |
graph_from_incidence_matrix | From incidence matrix |
graph_from_isomorphism_class | Create a graph from an isomorphism class |
graph_from_lcf | Creating a graph from LCF notation |
graph_from_literal | Creating (small) graphs via a simple interface |
graph.full | Create a full graph |
graph.full.bipartite | Create a full bipartite graph |
graph.full.citation | Create a complete (full) citation graph |
graph.graphdb | Load a graph from the graph database for testing graph... |
graph_id | Get the id of a graph |
graph.incidence | Create graphs from a bipartite adjacency matrix |
graph.intersection | Intersection of two or more sets |
graph.isocreate | Create a graph from an isomorphism class |
graph.kautz | Kautz graphs |
graph.knn | Average nearest neighbor degree |
graph.laplacian | Graph Laplacian |
graph.lattice | Create a lattice graph |
graph.lcf | Creating a graph from LCF notation |
graphlet_basis | Graphlet decomposition of a graph |
graphlets.candidate.basis | Graphlet decomposition of a graph |
graphlets.project | Graphlet decomposition of a graph |
graph.maxflow | Maximum flow in a graph |
graph.mincut | Minimum cut in a graph |
graph.motifs | Graph motifs |
graph.motifs.est | Graph motifs |
graph.motifs.no | Graph motifs |
graph.neighborhood | Neighborhood of graph vertices |
graph.ring | Create a ring graph |
graph.star | Create a star graph, a tree with n vertices and n - 1 leaves |
graph.strength | Strength or weighted vertex degree |
graph.tree | Create tree graphs |
graph.union | Union of graphs |
graph_version | igraph data structure versions |
greedy_vertex_coloring | Greedy vertex coloring |
grg.game | Geometric random graphs |
groups | Groups of a vertex partitioning |
growing.random.game | Growing random graph generation |
gsize | The size of the graph (number of edges) |
harmonic_centrality | Harmonic centrality of vertices |
has_eulerian_path | Find Eulerian paths or cycles in a graph |
has.multiple | Find the multiple or loop edges in a graph |
head_of | Head of the edge(s) in a graph |
head_print | Print the only the head of an R object |
hits_scores | Kleinberg's hub and authority centrality scores. |
hrg | Create a hierarchical random graph from an igraph graph |
hrg.consensus | Create a consensus tree from several hierarchical random... |
hrg.create | Create a hierarchical random graph from an igraph graph |
hrg.dendrogram | Create an igraph graph from a hierarchical random graph model |
hrg.fit | Fit a hierarchical random graph model |
hrg.game | Sample from a hierarchical random graph model |
hrg-methods | Hierarchical random graphs |
hrg.predict | Predict edges based on a hierarchical random graph model |
hrg_tree | Create an igraph graph from a hierarchical random graph model |
hub_score | Kleinberg's authority centrality scores. |
hub.score | Kleinberg's hub and authority centrality scores. |
identical_graphs | Decide if two graphs are identical |
igraph-attribute-combination | How igraph functions handle attributes when the graph changes |
igraph.console | The igraph console |
igraphdemo | Run igraph demos, step by step |
igraph_demo | Run igraph demos, step by step |
igraph-dollar | Getting and setting graph attributes, shortcut |
igraph-es-attributes | Query or set attributes of the edges in an edge sequence |
igraph-es-indexing | Indexing edge sequences |
igraph-es-indexing2 | Select edges and show their metadata |
igraph.from.graphNEL | Convert graphNEL objects from the graph package to igraph |
igraph-minus | Delete vertices or edges from a graph |
igraph_options | Parameters for the igraph package |
igraph.options | Parameters for the igraph package |
igraph.sample | Sampling a random integer sequence |
igraph.shape.noclip | Various vertex shapes when plotting igraph graphs |
igraph.shape.noplot | Various vertex shapes when plotting igraph graphs |
igraph.to.graphNEL | Convert igraph graphs to graphNEL objects from the graph... |
igraph_version | Query igraph's version string |
igraph.version | Query igraph's version string |
igraph-vs-attributes | Query or set attributes of the vertices in a vertex sequence |
igraph-vs-indexing | Indexing vertex sequences |
igraph-vs-indexing2 | Select vertices and show their metadata |
incident | Incident edges of a vertex in a graph |
incident_edges | Incident edges of multiple vertices in a graph |
indent_print | Indent a printout |
independence.number | Independent vertex sets |
independent.vertex.sets | Independent vertex sets |
induced.subgraph | Subgraph of a graph |
infomap.community | Infomap community finding |
inside-square-error | Helpers within vertex/index sequences |
interconnected.islands.game | A graph with subgraphs that are each a random graph. |
intersection | Intersection of two or more sets |
intersection.igraph | Intersection of graphs |
intersection.igraph.es | Intersection of edge sequences |
intersection.igraph.vs | Intersection of vertex sequences |
is_acyclic | Acyclic graphs |
is_biconnected | Check biconnectedness |
is_bipartite | Checks whether the graph has a vertex attribute called... |
is.bipartite | Checks whether the graph has a vertex attribute called 'type' |
is_chordal | Chordality of a graph |
is.chordal | Chordality of a graph |
is.connected | Connected components of a graph |
is_dag | Directed acyclic graphs |
is.dag | Directed acyclic graphs |
is.degree.sequence | Check if a degree sequence is valid for a multi-graph |
is_degseq | Check if a degree sequence is valid for a multi-graph |
is_directed | Check whether a graph is directed |
is.directed | Check whether a graph is directed |
is_forest | Decide whether a graph is a forest. |
is_graphical | Is a degree sequence graphical? |
is.graphical.degree.sequence | Is a degree sequence graphical? |
is.hierarchical | Functions to deal with the result of network community... |
is_igraph | Is this object an igraph graph? |
is.igraph | Is this object an igraph graph? |
is.loop | Find the multiple or loop edges in a graph |
is.matching | Matching |
is.maximal.matching | Matching |
is.minimal.separator | Minimal vertex separators |
is_min_separator | Minimal vertex separators |
is.multiple | Find the multiple or loop edges in a graph |
is.mutual | Find mutual edges in a directed graph |
is_named | Named graphs |
is.named | Named graphs |
isomorphic | Decide if two graphs are isomorphic |
isomorphism_class | Isomorphism class of a graph |
isomorphisms | Calculate all isomorphic mappings between the vertices of two... |
is_printer_callback | Is this a printer callback? |
is_separator | Check whether removing this set of vertices would disconnect... |
is.separator | Vertex separators |
is.simple | Simple graphs |
is_tree | Decide whether a graph is a tree. |
is_weighted | Weighted graphs |
is.weighted | Weighted graphs |
ivs | Independent vertex sets |
keeping_degseq | Graph rewiring while preserving the degree distribution |
knn | Average nearest neighbor degree |
k.regular.game | Create a random regular graph |
k_shortest_paths | Find the k shortest paths between two vertices |
label.propagation.community | Finding communities based on propagating labels |
laplacian_matrix | Graph Laplacian |
largest.cliques | Functions to find cliques, i.e. complete subgraphs in a graph |
largest.independent.vertex.sets | Independent vertex sets |
lastcit.game | Random citation graphs |
layout_ | Graph layouts |
layout_as_bipartite | Simple two-row layout for bipartite graphs |
layout_as_star | Generate coordinates to place the vertices of a graph in a... |
layout_as_tree | The Reingold-Tilford graph layout algorithm |
layout.auto | Choose an appropriate graph layout algorithm automatically |
layout.bipartite | Simple two-row layout for bipartite graphs |
layout.circle | Graph layout with vertices on a circle |
layout.davidson.harel | The Davidson-Harel layout algorithm |
layout.drl | The DrL graph layout generator |
layout.fruchterman.reingold | The Fruchterman-Reingold layout algorithm |
layout.fruchterman.reingold.grid | Grid Fruchterman-Reingold layout, this was removed from... |
layout.gem | The GEM layout algorithm |
layout.graphopt | The graphopt layout algorithm |
layout.grid | Simple grid layout |
layout.grid.3d | Simple grid layout |
layout_in_circle | Graph layout with vertices on a circle. |
layout.kamada.kawai | The Kamada-Kawai layout algorithm |
layout.lgl | Large Graph Layout |
layout.mds | Graph layout by multidimensional scaling |
layout.merge | Merging graph layouts |
layout_nicely | Choose an appropriate graph layout algorithm automatically |
layout.norm | Normalize coordinates for plotting graphs |
layout_on_grid | Simple grid layout |
layout_on_sphere | Graph layout with vertices on the surface of a sphere |
layout.random | Randomly place vertices on a plane or in 3d space |
layout_randomly | Randomly place vertices on a plane or in 3d space |
layout.reingold.tilford | The Reingold-Tilford graph layout algorithm |
layout.sphere | Graph layout with vertices on the surface of a sphere |
layout.spring | Spring layout, this was removed from igraph |
layout.star | Generate coordinates to place the vertices of a graph in a... |
layout.sugiyama | The Sugiyama graph layout generator |
layout.svd | SVD layout, this was removed from igraph |
layout_with_dh | The Davidson-Harel layout algorithm |
layout_with_drl | The DrL graph layout generator |
layout_with_fr | The Fruchterman-Reingold layout algorithm |
layout_with_gem | The GEM layout algorithm |
layout_with_graphopt | The graphopt layout algorithm |
layout_with_kk | The Kamada-Kawai layout algorithm |
layout_with_lgl | Large Graph Layout |
layout_with_mds | Graph layout by multidimensional scaling |
layout_with_sugiyama | The Sugiyama graph layout generator |
leading.eigenvector.community | Community structure detecting based on the leading... |
line.graph | Line graph of a graph |
list.edge.attributes | List names of edge attributes |
list.graph.attributes | List names of graph attributes |
list.vertex.attributes | List names of vertex attributes |
local_scan | Compute local scan statistics on graphs |
make_ | Make a new graph |
make_bipartite_graph | Create a bipartite graph |
make_chordal_ring | Create an extended chordal ring graph |
make_clusters | Creates a communities object. |
make_de_bruijn_graph | De Bruijn graphs |
make_empty_graph | A graph with no edges |
make_from_prufer | Create an undirected tree graph from its Prüfer sequence |
make_full_bipartite_graph | Create a full bipartite graph |
make_full_citation_graph | Create a complete (full) citation graph |
make_full_graph | Create a full graph |
make_graph | Create an igraph graph from a list of edges, or a notable... |
make_kautz_graph | Kautz graphs |
make_lattice | Create a lattice graph |
make_line_graph | Line graph of a graph |
make_ring | Create a ring graph |
make_star | Create a star graph, a tree with n vertices and n - 1 leaves |
make_tree | Create tree graphs |
matching | Matching |
match_vertices | Match Graphs given a seeding of vertex correspondences |
max_cardinality | Maximum cardinality search |
maxcohesion | Calculate Cohesive Blocks |
max_flow | Maximum flow in a graph |
maximal.cliques | Functions to find cliques, i.e. complete subgraphs in a graph |
maximal.cliques.count | Functions to find cliques, i.e. complete subgraphs in a graph |
maximal.independent.vertex.sets | Independent vertex sets |
maximal_ivs | Maximal independent vertex sets in the graph |
maximum.bipartite.matching | Matching |
maximum.cardinality.search | Maximum cardinality search |
merge_coords | Merging graph layouts |
min_cut | Minimum cut in a graph |
minimal.st.separators | Minimum size vertex separators |
minimum.size.separators | Minimum size vertex separators |
minimum.spanning.tree | Minimum spanning tree |
min_separators | Minimum size vertex separators |
min_st_separators | Minimum size vertex separators |
mod.matrix | Modularity of a community structure of a graph |
modularity.igraph | Modularity of a community structure of a graph |
motifs | Graph motifs |
mst | Minimum spanning tree |
multilevel.community | Finding community structure by multi-level optimization of... |
neighborhood.size | Neighborhood of graph vertices |
neighbors | Neighboring (adjacent) vertices in a graph |
no.clusters | Connected components of a graph |
normalize | Normalize layout |
norm_coords | Normalize coordinates for plotting graphs |
optimal.community | Optimal community structure |
page_rank | The Page Rank algorithm |
page.rank | The Page Rank algorithm |
path | Helper function to add or delete edges along a path |
path.length.hist | Shortest (directed or undirected) paths between vertices |
permute | Permute the vertices of a graph |
permute.vertices | Permute the vertices of a graph |
piecewise.layout | Merging graph layouts |
pipe | Magrittr's pipes |
plot.common | Drawing graphs |
plot_dendrogram.communities | Community structure dendrogram plots |
plot_dendrogram.igraphHRG | HRG dendrogram plot |
plotHierarchy | Calculate Cohesive Blocks |
plot.igraph | Plotting of graphs |
plot.sir | Plotting the results on multiple SIR model runs |
plus-.igraph | Add vertices, edges or another graph to a graph |
power_centrality | Find Bonacich Power Centrality Scores of Network Positions |
power.law.fit | Fitting a power-law distribution function to discrete data |
predict_edges | Predict edges based on a hierarchical random graph model |
preference.game | Trait-based random generation |
printer_callback | Create a printer callback function |
print.igraph | Print graphs to the terminal |
print.igraph.es | Print an edge sequence to the screen |
print.igraphHRG | Print a hierarchical random graph model to the screen |
print.igraphHRGConsensus | Print a hierarchical random graph consensus tree to the... |
print.igraph.vs | Show a vertex sequence on the screen |
radius | Radius of a graph |
random_walk | Random walk on a graph |
read_graph | Reading foreign file formats |
read.graph | Reading foreign file formats |
realize_bipartite_degseq | Creating a bipartite graph from two degree sequences,... |
realize_degseq | Creating a graph from a given degree sequence,... |
reciprocity | Reciprocity of graphs |
remove.edge.attribute | Delete an edge attribute |
remove.graph.attribute | Delete a graph attribute |
remove.vertex.attribute | Delete a vertex attribute |
rep.igraph | Replicate a graph multiple times |
reverse_edges | Reverse edges in a graph |
rev.igraph.es | Reverse the order in an edge sequence |
rev.igraph.vs | Reverse the order in a vertex sequence |
rewire | Rewiring edges of a graph |
rglplot | 3D plotting of graphs with OpenGL |
r_pal | The default R palette |
running_mean | Running mean of a time series |
running.mean | Running mean of a time series |
sample_ | Sample from a random graph model |
sample_bipartite | Bipartite random graphs |
sample_chung_lu | Random graph with given expected degrees |
sample_correlated_gnp | Generate a new random graph from a given graph by randomly... |
sample_correlated_gnp_pair | Sample a pair of correlated G(n,p) random graphs |
sample_degseq | Generate random graphs with a given degree sequence |
sample_dirichlet | Sample from a Dirichlet distribution |
sample_dot_product | Generate random graphs according to the random dot product... |
sample_fitness | Random graphs from vertex fitness scores |
sample_fitness_pl | Scale-free random graphs, from vertex fitness scores |
sample_forestfire | Forest Fire Network Model |
sample_gnm | Generate random graphs according to the G(n,m) Erdős-Rényi... |
sample_gnp | Generate random graphs according to the G(n,p) Erdős-Rényi... |
sample_grg | Geometric random graphs |
sample_growing | Growing random graph generation |
sample_hierarchical_sbm | Sample the hierarchical stochastic block model |
sample_hrg | Sample from a hierarchical random graph model |
sample_islands | A graph with subgraphs that are each a random graph. |
sample_k_regular | Create a random regular graph |
sample_last_cit | Random citation graphs |
sample_motifs | Graph motifs |
sample_pa | Generate random graphs using preferential attachment |
sample_pa_age | Generate an evolving random graph with preferential... |
sample_pref | Trait-based random generation |
sample_sbm | Sample stochastic block model |
sample_seq | Sampling a random integer sequence |
sample_smallworld | The Watts-Strogatz small-world model |
sample_spanning_tree | Samples from the spanning trees of a graph randomly and... |
sample_sphere_surface | Sample vectors uniformly from the surface of a sphere |
sample_sphere_volume | Sample vectors uniformly from the volume of a sphere |
sample_traits_callaway | Graph generation based on different vertex types |
sample_tree | Sample trees randomly and uniformly |
sbm.game | Sample stochastic block model |
scan_stat | Scan statistics on a time series of graphs |
sequential_pal | Sequential palette |
set_edge_attr | Set edge attributes |
set.edge.attribute | Set edge attributes |
set_graph_attr | Set a graph attribute |
set.graph.attribute | Set a graph attribute |
set_vertex_attr | Set vertex attributes |
set.vertex.attribute | Set vertex attributes |
shapes | Various vertex shapes when plotting igraph graphs |
shortest.paths | Shortest (directed or undirected) paths between vertices |
showtrace | Functions to deal with the result of network community... |
similarity | Similarity measures of two vertices |
similarity.dice | Similarity measures of two vertices (Dice) |
similarity.invlogweighted | Similarity measures of two vertices (inverse log-weighted) |
similarity.jaccard | Similarity measures of two vertices (Jaccard) |
simplified | Constructor modifier to drop multiple and loop edges |
simplify | Simple graphs |
sir | SIR model on graphs |
spectrum | Eigenvalues and eigenvectors of the adjacency matrix of a... |
spinglass.community | Finding communities in graphs based on statistical meachanics |
split_join_distance | Split-join distance of two community structures |
static.fitness.game | Random graphs from vertex fitness scores |
static.power.law.game | Scale-free random graphs, from vertex fitness scores |
st_cuts | List all (s,t)-cuts of a graph |
stCuts | List all (s,t)-cuts of a graph |
st_min_cuts | List all minimum (s,t)-cuts of a graph |
stMincuts | List all minimum \((s,t)\)-cuts of a graph |
stochastic_matrix | Stochastic matrix of a graph |
strength | Strength or weighted vertex degree |
subcomponent | In- or out- component of a vertex |
subgraph | Subgraph of a graph |
subgraph_centrality | Find subgraph centrality scores of network positions |
subgraph.centrality | Find subgraph centrality scores of network positions |
subgraph.edges | Subgraph of a graph |
subgraph_isomorphic | Decide if a graph is subgraph isomorphic to another one |
subgraph_isomorphisms | All isomorphic mappings between a graph and subgraphs of... |
sub-.igraph | Query and manipulate a graph as it were an adjacency matrix |
sub-sub-.igraph | Query and manipulate a graph as it were an adjacency list |
tail_of | Tails of the edge(s) in a graph |
tkigraph | tkigraph |
tkplot | Interactive plotting of graphs |
tkplot.canvas | Interactive plotting of graphs |
tkplot.center | Interactive plotting of graphs |
tkplot.close | Interactive plotting of graphs |
tkplot.export.postscript | Interactive plotting of graphs |
tkplot.fit.to.screen | Interactive plotting of graphs |
tkplot.getcoords | Interactive plotting of graphs |
tkplot.off | Interactive plotting of graphs |
tkplot.reshape | Interactive plotting of graphs |
tkplot.rotate | Interactive plotting of graphs |
tkplot.setcoords | Interactive plotting of graphs |
topological.sort | Topological sorting of vertices in a graph |
topo_sort | Topological sorting of vertices in a graph |
to_prufer | Convert a tree graph to its Prüfer sequence |
transitivity | Transitivity of a graph |
triad_census | Triad census, subgraphs with three vertices |
triad.census | Triad census, subgraphs with three vertices |
unfold_tree | Convert a general graph into a forest |
unfold.tree | Convert a general graph into a forest |
union | Union of two or more sets |
union.igraph | Union of graphs |
union.igraph.es | Union of edge sequences |
union.igraph.vs | Union of vertex sequences |
unique.igraph.es | Remove duplicate edges from an edge sequence |
unique.igraph.vs | Remove duplicate vertices from a vertex sequence |
upgrade_graph | igraph data structure versions |
V | Vertices of a graph |
vertex | Helper function for adding and deleting vertices |
vertex_attr | Query vertex attributes of a graph |
vertex_attr_names | List names of vertex attributes |
vertex_attr-set | Set one or more vertex attributes |
vertex_connectivity | Vertex connectivity |
vertex.connectivity | Vertex connectivity |
vertex.disjoint.paths | Vertex connectivity |
vertex.shape.pie | Using pie charts as vertices in graph plots |
vertex.shapes | Various vertex shapes when plotting igraph graphs |
voronoi_cells | Voronoi partitioning of a graph |
walktrap.community | Community structure via short random walks |
watts.strogatz.game | The Watts-Strogatz small-world model |
weighted_cliques | Functions to find weighted cliques, i.e. vertex-weighted... |
which_multiple | Find the multiple or loop edges in a graph |
which_mutual | Find mutual edges in a directed graph |
with_edge_ | Constructor modifier to add edge attributes |
with_graph_ | Constructor modifier to add graph attributes |
with_igraph_opt | Run code with a temporary igraph options setting |
without_attr | Construtor modifier to remove all attributes from a graph |
without_loops | Constructor modifier to drop loop edges |
without_multiples | Constructor modifier to drop multiple edges |
with_vertex_ | Constructor modifier to add vertex attributes |
write_graph | Writing the graph to a file in some format |
write.graph | Writing the graph to a file in some format |
Add the following code to your website.
For more information on customizing the embed code, read Embedding Snippets.