RDocumentation
Moon
Search all packages and functions
⚠️
There's a newer version (1.3.2) of this package.
Take me there.
Readme not available 😞
Copy Link
Copy
Link to current version
Version
Version
1.3.2
1.3.1
1.3.0
1.2.11
1.2.10
1.2.9
1.2.8
1.2.7
1.2.6
1.2.5
1.2.4.2
1.2.4.1
1.2.4
1.2.3
1.2.2
1.2.1
1.1.2
1.1.1
1.0.1
1.0.0
0.7.1
0.7.0
0.6.6
0.6.5-2
0.6.5-1
0.6.4
0.6-3
0.6-2
0.6-1
0.5.5-4
0.5.5-3
0.5.5-2
0.5.5-1
0.5.4-1
0.5.3
0.5.2-2
0.5.1
0.4.5
0.4.4
0.4.3
0.4.2
0.4.1
0.3.3
0.3.2
0.3.1
0.2.1
0.1.2
0.1.1
Down Chevron
Install
install.packages('igraph')
Monthly Downloads
347,062
Version
1.2.9
License
GPL (>= 2)
Maintainer
Tam<c3><a1>s Nepusz
Last Published
November 23rd, 2021
Functions in igraph (1.2.9)
Search functions
add_vertices
Add vertices to a graph
V
Vertices of a graph
igraph-package
The igraph package
alpha_centrality
Find Bonacich alpha centrality scores of network positions
add_layout_
Add layout to graph
E
Edges of a graph
are_adjacent
Are two vertices adjacent?
adjacent_vertices
Adjacent vertices of multiple vertices in a graph
add_edges
Add edges to a graph
all_simple_paths
List all simple paths from one source
as_edgelist
Convert a graph to an edge list
as_incidence_matrix
Incidence matrix of a bipartite graph
as_ids
Convert a vertex or edge sequence to an ordinary vector
automorphisms
Number of automorphisms
bipartite_mapping
Decide whether a graph is bipartite
as.directed
Convert between directed and undirected graphs
as.igraph
Conversion to igraph
bipartite_projection
Project a bipartite graph
estimate_betweenness
Vertex and edge betweenness centrality
authority_score
Kleinberg's authority centrality scores.
assortativity
Assortativity coefficient
centr_betw
Centralize a graph according to the betweenness of vertices
centr_betw_tmax
Theoretical maximum for betweenness centralization
articulation_points
Articulation points of a graph
as_long_data_frame
Convert a graph to a long data frame
arpack_defaults
ARPACK eigenvector calculation
c.igraph.vs
Concatenate vertex sequences
c.igraph.es
Concatenate edge sequences
cluster_infomap
Infomap community finding
cluster_label_prop
Finding communities based on propagating labels
centr_clo
Centralize a graph according to the closeness of vertices
centr_clo_tmax
Theoretical maximum for closeness centralization
as_graphnel
Convert igraph graphs to graphNEL objects from the graph package
centr_degree
Centralize a graph according to the degrees of vertices
as_adj_list
Adjacency lists
cluster_fast_greedy
Community structure via greedy optimization of modularity
centr_degree_tmax
Theoretical maximum for degree centralization
cluster_fluid_communities
Community detection algorithm based on interacting fluids
cluster_walktrap
Community strucure via short random walks
cluster_spinglass
Finding communities in graphs based on statistical meachanics
biconnected_components
Biconnected components
as_adjacency_matrix
Convert a graph to an adjacency matrix
bfs
Breadth-first search
canonical_permutation
Canonical permutation of a graph
centralize
Centralization of a graph
as_membership
Declare a numeric vector as a membership vector
categorical_pal
Palette for categories
centr_eigen_tmax
Theoretical maximum for betweenness centralization
centr_eigen
Centralize a graph according to the eigenvector centrality of vertices
cocitation
Cocitation coupling
convex_hull
Convex hull of a set of vertices
cluster_louvain
Finding community structure by multi-level optimization of modularity
cluster_optimal
Optimal community structure
constraint
Burt's constraint
difference
Difference of two sets
coreness
K-core decomposition of graphs
closeness
Closeness centrality of vertices
cluster_leiden
Finding community structure of a graph using the Leiden algorithm of Traag, van Eck & Waltman.
compose
Compose two graphs as binary relations
cluster_edge_betweenness
Community structure detection based on edge betweenness
cluster_leading_eigen
Community structure detecting based on the leading eigenvector of the community matrix
component_distribution
Connected components of a graph
membership
Functions to deal with the result of network community detection
compare
Compares community structures using various metrics
complementer
Complementer of a graph
cliques
The functions find cliques, ie. complete subgraphs in a graph
consensus_tree
Create a consensus tree from several hierarchical random graph models
component_wise
Component-wise layout
count_triangles
Find triangles in graphs
count_subgraph_isomorphisms
Count the isomorphic mappings between a graph and the subgraphs of another graph
dim_select
Dimensionality selection for singular values using profile likelihood.
contract
Contract several vertices into a single one
curve_multiple
Optimal edge curvature when plotting graphs
distance_table
Shortest (directed or undirected) paths between vertices
diverging_pal
Diverging palette
eigen_centrality
Find Eigenvector Centrality Scores of Network Positions
decompose
Decompose a graph into components
cohesive_blocks
Calculate Cohesive Blocks
count_isomorphisms
Count the number of isomorphic mappings between two graphs
disjoint_union
Disjoint union of graphs
diversity
Graph diversity
count_motifs
Graph motifs
dominator_tree
Dominator tree
girth
Girth of a graph
embed_adjacency_matrix
Spectral Embedding of Adjacency Matrices
gorder
Order (number of vertices) of a graph
graph_id
Get the id of a graph
graph_from_literal
Creating (small) graphs via a simple interface
graph_from_graphnel
Convert graphNEL objects from the graph package to igraph
graph_from_adj_list
Create graphs from adjacency lists
degree
Degree and degree distribution of the vertices
igraph_version
Query igraph's version string
difference.igraph
Difference of graphs
console
The igraph console
graph_from_adjacency_matrix
Create graphs from adjacency matrices
graph_from_incidence_matrix
Create graphs from an incidence matrix
delete_vertex_attr
Delete a vertex attribute
dyad_census
Dyad census of a graph
delete_edge_attr
Delete an edge attribute
delete_vertices
Delete vertices from a graph
graph_version
Igraph data structure versions
difference.igraph.vs
Difference of vertex sequences
difference.igraph.es
Difference of edge sequences
ends
Incident vertices of some graph edges
embed_laplacian_matrix
Spectral Embedding of the Laplacian of a Graph
incident
Incident edges of a vertex in a graph
graph_
Convert object to a graph
edge_attr<-
Set one or more edge attributes
intersection.igraph.es
Intersection of edge sequences
intersection.igraph.vs
Intersection of vertex sequences
graphlet_basis
Graphlet decomposition of a graph
groups
Groups of a vertex partitioning
edge_density
Graph density
fit_power_law
Fitting a power-law distribution function to discrete data
gsize
The size of the graph (number of edges)
get.edge.ids
Find the edge ids based on the incident vertices of the edges
delete_graph_attr
Delete a graph attribute
delete_edges
Delete edges from a graph
dfs
Depth-first search
each_edge
Rewires the endpoints of the edges of a graph to a random vertex
ego_size
Neighborhood of graph vertices
hub_score
Kleinberg's hub centrality scores.
igraph-attribute-combination
How igraph functions handle attributes when the graph changes
igraph-dollar
Getting and setting graph attributes, shortcut
edge_attr_names
List names of edge attributes
eccentricity
Eccentricity of the vertices in a graph
edge
Helper function for adding and deleting edges
diameter
Diameter of a graph
igraph_options
Parameters for the igraph package
identical_graphs
Decide if two graphs are identical
igraph-vs-indexing2
Select vertices and show their metadata
edge_connectivity
Edge connectivity.
graph_attr
Graph attributes of a graph
layout_as_tree
The Reingold-Tilford graph layout algorithm
layout_as_star
Generate coordinates to place the vertices of a graph in a star-shape
layout.svd
SVD layout, this was removed from igraph
is_named
Named graphs
isomorphisms
Calculate all isomorphic mappings between the vertices of two graphs
isomorphism_class
Isomorphism class of a graph
is_min_separator
Minimal vertex separators
layout.spring
Spring layout, this was removed from igraph
igraph_demo
Run igraph demos, step by step
layout_on_grid
Simple grid layout
graph_attr<-
Set all or some graph attributes
layout_with_lgl
Large Graph Layout
layout_with_kk
The Kamada-Kawai layout algorithm
graph_attr_names
List names of graph attributes
graph_from_isomorphism_class
Create a graph from an isomorphism class
graph_from_lcf
Creating a graph from LCF notation
make_star
Create a star graph, a tree with n vertices and n - 1 leaves
make_clusters
Creates a communities object.
make_ring
Create a ring graph
make_de_bruijn_graph
De Bruijn graphs
layout_on_sphere
Graph layout with vertices on the surface of a sphere
min_cut
Minimum cut in a graph
handle_vertex_type_arg
Common handler for vertex type arguments in igraph functions
head_of
Head of the edge(s) in a graph
permute
Permute the vertices of a graph
min_separators
Minimum size vertex separators
%>%
Magrittr's pipes
r_pal
The default R palette
printr
Better printing of R packages
igraph-es-indexing2
Select edges and show their metadata
intersection.igraph
Intersection of graphs
intersection
Intersection of two or more sets
igraph-minus
Delete vertices or edges from a graph
is_dag
Directed acyclic graphs
is_chordal
Chordality of a graph
keeping_degseq
Graph rewiring while preserving the degree distribution
igraph_test
Run package tests
ivs
Independent vertex sets
is_directed
Check whether a graph is directed
is_degseq
Check if a degree sequence is valid for a multi-graph
max_flow
Maximum flow in a graph
page_rank
The Page Rank algorithm
edge_attr
Query edge attributes of a graph
erdos.renyi.game
Generate random graphs according to the Erdos-Renyi model
merge_coords
Merging graph layouts
sample_hrg
Sample from a hierarchical random graph model
sample_hierarchical_sbm
Sample the hierarchical stochastic block model
print.igraph.es
Print an edge sequence to the screen
path
Helper function to add or delete edges along a path
print.igraph
Print graphs to the terminal
print.igraphHRGConsensus
Print a hierarchical random graph consensus tree to the screen
printer_callback
Create a printer callback function
knn
Average nearest neighbor degree
layout.fruchterman.reingold.grid
Grid Fruchterman-Reingold layout, this was removed from igraph
is_bipartite
Create a bipartite graph
layout.reingold.tilford
Deprecated layout functions
fit_hrg
Fit a hierarchical random graph model
make_full_citation_graph
Create a complete (full) citation graph
make_chordal_ring
Create an extended chordal ring graph
graph_from_atlas
Create a graph from the Graph Atlas
as_data_frame
Creating igraph graphs from data frames or vice-versa
rglplot
3D plotting of graphs with OpenGL
running_mean
Running mean of a time series
sample_grg
Geometric random graphs
sample_growing
Growing random graph generation
hrg_tree
Create an igraph graph from a hierarchical random graph model
hrg
Create a hierarchical random graph from an igraph graph
sample_traits_callaway
Graph generation based on different vertex types
simplified
Constructor modifier to drop multiple and loop edges
scan_stat
Scan statistics on a time series of graphs
similarity
Similarity measures of two vertices
scg-method
Spectral Coarse Graining
sample_pa
Generate scale-free graphs according to the Barabasi-Albert model
sample_pa_age
Generate an evolving random graph with preferential attachment and aging
graph_from_edgelist
Create a graph from an edge list matrix
head_print
Print the only the head of an R object
graph_from_graphdb
Load a graph from the graph database for testing graph isomorphism.
subgraph
Subgraph of a graph
igraph-vs-indexing
Indexing vertex sequences
igraph-vs-attributes
Query or set attributes of the vertices in a vertex sequence
hrg-methods
Hierarchical random graphs
make_full_graph
Create a full graph
motifs
Graph motifs
mst
Minimum spanning tree
strength
Strength or weighted vertex degree
scg
All-in-one Function for the SCG of Matrices and Graphs
Drawing graphs
Drawing graphs
make_empty_graph
A graph with no edges
layout_with_dh
The Davidson-Harel layout algorithm
layout_randomly
Randomly place vertices on a plane or in 3d space
laplacian_matrix
Graph Laplacian
make_full_bipartite_graph
Create a full bipartite graph
igraph-es-attributes
Query or set attributes of the edges in an edge sequence
igraph-es-indexing
Indexing edge sequences
power_centrality
Find Bonacich Power Centrality Scores of Network Positions
plot.igraph
Plotting of graphs
[.igraph
Query and manipulate a graph as it were an adjacency matrix
predict_edges
Predict edges based on a hierarchical random graph model
rev.igraph.vs
Reverse the order in a vertex sequence
is_igraph
Is this object an igraph graph?
is_printer_callback
Is this a printer callback?
is_graphical
Is a degree sequence graphical?
rewire
Rewiring edges of a graph
sample_motifs
Graph motifs
sample_last_cit
Random citation graphs
union
Union of two or more sets
unfold_tree
Convert a general graph into a forest
subgraph_centrality
Find subgraph centrality scores of network positions
union.igraph
Union of graphs
vertex
Helper function for adding and deleting vertices
indent_print
Indent a printout
spectrum
Eigenvalues and eigenvectors of the adjacency matrix of a graph
union.igraph.es
Union of edge sequences
with_edge_
Constructor modifier to add edge attributes
incident_edges
Incident edges of multiple vertices in a graph
with_graph_
Constructor modifier to add graph attributes
is_weighted
Weighted graphs
split_join_distance
Split-join distance of two community structures
Pie charts as vertices
Using pie charts as vertices in graph plots
is_separator
Vertex separators
match_vertices
Match Graphs given a seeding of vertex correspondences
make_tree
Create tree graphs
tail_of
Tails of the edge(s) in a graph
tkigraph
Experimental basic igraph GUI
layout_in_circle
Graph layout with vertices on a circle.
isomorphic
Decide if two graphs are isomorphic
layout_with_drl
The DrL graph layout generator
layout_nicely
Choose an appropriate graph layout algorithm automatically
without_loops
Constructor modifier to drop loop edges
without_attr
Construtor modifier to remove all attributes from a graph
min_st_separators
Minimum size vertex separators
modularity.igraph
Modularity of a community structure of a graph
layout_with_mds
Graph layout by multidimensional scaling
layout_with_fr
The Fruchterman-Reingold layout algorithm
print.igraph.vs
Show a vertex sequence on the screen
layout_with_sugiyama
The Sugiyama graph layout generator
sample_correlated_gnp
Generate a new random graph from a given graph by randomly adding/removing edges
reciprocity
Reciprocity of graphs
print.igraphHRG
Print a hierarchical random graph model to the screen
read_graph
Reading foreign file formats
layout_
Graph layouts
layout_with_graphopt
The graphopt layout algorithm
layout_with_gem
The GEM layout algorithm
sample_correlated_gnp_pair
Sample a pair of correlated G(n,p) random graphs
layout_as_bipartite
Simple two-row layout for bipartite graphs
sample_fitness_pl
Scale-free random graphs, from vertex fitness scores
local_scan
Compute local scan statistics on graphs
make_
Make a new graph
make_graph
Create an igraph graph from a list of edges, or a notable graph
sample_islands
A graph with subgraphs that are each a random graph.
make_lattice
Create a lattice graph
sample_forestfire
Forest Fire Network Model
sample_sphere_volume
Sample vectors uniformly from the volume of a sphere
sample_sphere_surface
Sample vectors uniformly from the surface of a sphere
sample_k_regular
Create a random regular graph
make_line_graph
Line graph of a graph
plot_dendrogram.igraphHRG
HRG dendrogram plot
neighbors
Neighboring (adjacent) vertices in a graph
+.igraph
Add vertices, edges or another graph to a graph
print.nexusDatasetInfo
Query and download from the Nexus network repository
make_kautz_graph
Kautz graphs
simplify
Simple graphs
is_matching
Graph matching
subgraph_isomorphisms
All isomorphic mappings between a graph and subgraphs of another graph
[[.igraph
Query and manipulate a graph as it were an adjacency list
subgraph_isomorphic
Decide if a graph is subgraph isomorphic to another one
subcomponent
In- or out- component of a vertex
vertex_attr<-
Set one or more vertex attributes
vertex_attr
Query vertex attributes of a graph
time_bins.sir
SIR model on graphs
max_cardinality
Maximum cardinality search
radius
Radius of a graph
norm_coords
Normalize coordinates for plotting graphs
normalize
Normalize layout
sample_
Sample from a random graph model
random_walk
Random walk on a graph
sample_dot_product
Generate random graphs according to the random dot product graph model
sample_bipartite
Bipartite random graphs
without_multiples
Constructor modifier to drop multiple edges
which_multiple
Find the multiple or loop edges in a graph
which_mutual
Find mutual edges in a directed graph
write_graph
Writing the graph to a file in some format
rep.igraph
Replicate a graph multiple times
rev.igraph.es
Reverse the order in an edge sequence
plot_dendrogram
Community structure dendrogram plots
plot.sir
Plotting the results on multiple SIR model runs
sample_degseq
Generate random graphs with a given degree sequence
scg_eps
Error of the spectral coarse graining (SCG) approximation
sample_gnm
Generate random graphs according to the G(n,m) Erdos-Renyi model
sample_dirichlet
Sample from a Dirichlet distribution
sample_seq
Sampling a random integer sequence
sample_smallworld
The Watts-Strogatz small-world model
sample_fitness
Random graphs from vertex fitness scores
sample_gnp
Generate random graphs according to the G(n,p) Erdos-Renyi model
sample_pref
Trait-based random generation
sample_sbm
Sample stochastic block model
sequential_pal
Sequential palette
set_graph_attr
Set a graph attribute
set_edge_attr
Set edge attributes
scg_semi_proj
Semi-Projectors
set_vertex_attr
Set vertex attributes
scg_group
SCG Problem Solver
shapes
Various vertex shapes when plotting igraph graphs
srand
Deprecated function, used to set random seed of the C library's RNG
st_cuts
List all (s,t)-cuts of a graph
st_min_cuts
List all minimum \((s,t)\)-cuts of a graph
stochastic_matrix
Stochastic matrix of a graph
triad_census
Triad census, subgraphs with three vertices
unique.igraph.vs
Remove duplicate vertices from a vertex sequence
transitivity
Transitivity of a graph
vertex_attr_names
List names of vertex attributes
upgrade_graph
Igraph data structure versions
vertex_connectivity
Vertex connectivity.
tkplot
Interactive plotting of graphs
topo_sort
Topological sorting of vertices in a graph
union.igraph.vs
Union of vertex sequences
with_igraph_opt
Run code with a temporary igraph options setting
unique.igraph.es
Remove duplicate edges from an edge sequence
with_vertex_
Constructor modifier to add vertex attributes