Man pages for igraph
Network Analysis and Visualization

aaa-igraph-packageThe igraph package
add_edgesAdd edges to a graph
add_layout_Add layout to graph
add_verticesAdd vertices to a graph
adjacent_verticesAdjacent vertices of multiple vertices in a graph
all_simple_pathsList all simple paths from one source
alpha_centralityFind Bonacich alpha centrality scores of network positions
are_adjacentAre two vertices adjacent?
arpackARPACK eigenvector calculation
articulation_pointsArticulation points and bridges of a graph
as_adjacency_matrixConvert a graph to an adjacency matrix
as_adj_listAdjacency lists
as.directedConvert between directed and undirected graphs
as_edgelistConvert a graph to an edge list
as_graphnelConvert igraph graphs to graphNEL objects from the graph...
as_idsConvert a vertex or edge sequence to an ordinary vector
as.igraphConversion to igraph
as_incidence_matrixIncidence matrix of a bipartite graph
as_long_data_frameConvert a graph to a long data frame
as.matrix.igraphConvert igraph objects to adjacency or edge list matrices
as_membershipDeclare a numeric vector as a membership vector
assortativityAssortativity coefficient
automorphism_groupGenerating set of the automorphism group of a graph
betweennessVertex and edge betweenness centrality
bfsBreadth-first search
biconnected_componentsBiconnected components
bipartite_mappingDecide whether a graph is bipartite
bipartite_projectionProject a bipartite graph
canonical_permutationCanonical permutation of a graph
categorical_palPalette for categories
centralizeCentralization of a graph
centr_betwCentralize a graph according to the betweenness of vertices
centr_betw_tmaxTheoretical maximum for betweenness centralization
centr_cloCentralize a graph according to the closeness of vertices
centr_clo_tmaxTheoretical maximum for closeness centralization
centr_degreeCentralize a graph according to the degrees of vertices
centr_degree_tmaxTheoretical maximum for degree centralization
centr_eigenCentralize a graph according to the eigenvector centrality of...
centr_eigen_tmaxTheoretical maximum for betweenness centralization
c.igraph.esConcatenate edge sequences
c.igraph.vsConcatenate vertex sequences
cliquesFunctions to find cliques, i.e. complete subgraphs in a graph
closenessCloseness centrality of vertices
cluster_edge_betweennessCommunity structure detection based on edge betweenness
cluster_fast_greedyCommunity structure via greedy optimization of modularity
cluster_fluid_communitiesCommunity detection algorithm based on interacting fluids
cluster_infomapInfomap community finding
cluster_label_propFinding communities based on propagating labels
cluster_leading_eigenCommunity structure detecting based on the leading...
cluster_leidenFinding community structure of a graph using the Leiden...
cluster_louvainFinding community structure by multi-level optimization of...
cluster_optimalOptimal community structure
cluster_spinglassFinding communities in graphs based on statistical meachanics
cluster_walktrapCommunity structure via short random walks
cocitationCocitation coupling
cohesive_blocksCalculate Cohesive Blocks
communitiesFunctions to deal with the result of network community...
compareCompares community structures using various metrics
complementerComplementer of a graph
componentsConnected components of a graph
component_wiseComponent-wise layout
composeCompose two graphs as binary relations
consensus_treeCreate a consensus tree from several hierarchical random...
consoleThe igraph console
constraintBurt's constraint
contractContract several vertices into a single one
convex_hullConvex hull of a set of vertices
corenessK-core decomposition of graphs
count_automorphismsNumber of automorphisms
count_isomorphismsCount the number of isomorphic mappings between two graphs
count_motifsGraph motifs
count_subgraph_isomorphismsCount the isomorphic mappings between a graph and the...
count_trianglesFind triangles in graphs
curve_multipleOptimal edge curvature when plotting graphs
decomposeDecompose a graph into components
degreeDegree and degree distribution of the vertices
delete_edge_attrDelete an edge attribute
delete_edgesDelete edges from a graph
delete_graph_attrDelete a graph attribute
delete_vertex_attrDelete a vertex attribute
delete_verticesDelete vertices from a graph
dfsDepth-first search
diameterDiameter of a graph
differenceDifference of two sets
difference.igraphDifference of graphs
difference.igraph.esDifference of edge sequences
difference.igraph.vsDifference of vertex sequences
dim_selectDimensionality selection for singular values using profile...
disjoint_unionDisjoint union of graphs
distancesShortest (directed or undirected) paths between vertices
diverging_palDiverging palette
diversityGraph diversity
dominator_treeDominator tree
dot-data'.data' and '.env' pronouns
dyad_censusDyad census of a graph
EEdges of a graph
each_edgeRewires the endpoints of the edges of a graph to a random...
eccentricityEccentricity of the vertices in a graph
edgeHelper function for adding and deleting edges
edge_attrQuery edge attributes of a graph
edge_attr_namesList names of edge attributes
edge_attr-setSet one or more edge attributes
edge_connectivityEdge connectivity
edge_densityGraph density
egoNeighborhood of graph vertices
eigen_centralityFind Eigenvector Centrality Scores of Network Positions
embed_adjacency_matrixSpectral Embedding of Adjacency Matrices
embed_laplacian_matrixSpectral Embedding of the Laplacian of a Graph
endsIncident vertices of some graph edges
erdos.renyi.gameGenerate random graphs according to the Erdős-Rényi model
estimate_betweennessDeprecated version of 'betweenness()'
estimate_closenessDeprecated version of 'closeness()'
estimate_edge_betweennessDeprecated version of 'edge_betweenness()'
feedback_arc_setFinding a feedback arc set in a graph
fit_hrgFit a hierarchical random graph model
fit_power_lawFitting a power-law distribution function to discrete data
get.edge.idsFind the edge ids based on the incident vertices of the edges
girthGirth of a graph
global_efficiencyEfficiency of a graph
gorderOrder (number of vertices) of a graph
graph_Convert object to a graph
graph_attrGraph attributes of a graph
graph_attr_namesList names of graph attributes
graph_attr-setSet all or some graph attributes
graph_from_adjacency_matrixCreate graphs from adjacency matrices
graph_from_adj_listCreate graphs from adjacency lists
graph_from_atlasCreate a graph from the Graph Atlas
graph_from_data_frameCreating igraph graphs from data frames or vice-versa
graph_from_edgelistCreate a graph from an edge list matrix
graph_from_graphdbLoad a graph from the graph database for testing graph...
graph_from_graphnelConvert graphNEL objects from the graph package to igraph
graph_from_incidence_matrixCreate graphs from an incidence matrix
graph_from_isomorphism_classCreate a graph from an isomorphism class
graph_from_lcfCreating a graph from LCF notation
graph_from_literalCreating (small) graphs via a simple interface
graph_idGet the id of a graph
graphlet_basisGraphlet decomposition of a graph
graph_versionigraph data structure versions
greedy_vertex_coloringGreedy vertex coloring
groupsGroups of a vertex partitioning
gsizeThe size of the graph (number of edges)
handle_vertex_type_argCommon handler for vertex type arguments in igraph functions
harmonic_centralityHarmonic centrality of vertices
has_eulerian_pathFind Eulerian paths or cycles in a graph
head_ofHead of the edge(s) in a graph
head_printPrint the only the head of an R object
hrgCreate a hierarchical random graph from an igraph graph
hrg-methodsHierarchical random graphs
hrg_treeCreate an igraph graph from a hierarchical random graph model
hub_scoreKleinberg's hub and authority centrality scores.
identical_graphsDecide if two graphs are identical
igraph-attribute-combinationHow igraph functions handle attributes when the graph changes
igraph_demoRun igraph demos, step by step
igraph-dollarGetting and setting graph attributes, shortcut
igraph-es-attributesQuery or set attributes of the edges in an edge sequence
igraph-es-indexingIndexing edge sequences
igraph-es-indexing2Select edges and show their metadata
igraph-minusDelete vertices or edges from a graph
igraph_optionsParameters for the igraph package
igraph_testRun package tests
igraph_versionQuery igraph's version string
igraph-vs-attributesQuery or set attributes of the vertices in a vertex sequence
igraph-vs-indexingIndexing vertex sequences
igraph-vs-indexing2Select vertices and show their metadata
incidentIncident edges of a vertex in a graph
incident_edgesIncident edges of multiple vertices in a graph
indent_printIndent a printout
intersectionIntersection of two or more sets
intersection.igraphIntersection of graphs
intersection.igraph.esIntersection of edge sequences
intersection.igraph.vsIntersection of vertex sequences
is_chordalChordality of a graph
is_dagDirected acyclic graphs
is_degseqCheck if a degree sequence is valid for a multi-graph
is_directedCheck whether a graph is directed
is_graphicalIs a degree sequence graphical?
is_igraphIs this object an igraph graph?
is_min_separatorMinimal vertex separators
is_namedNamed graphs
isomorphicDecide if two graphs are isomorphic
isomorphism_classIsomorphism class of a graph
isomorphismsCalculate all isomorphic mappings between the vertices of two...
is_printer_callbackIs this a printer callback?
is_separatorVertex separators
is_treeDecide whether a graph is a tree.
is_weightedWeighted graphs
ivsIndependent vertex sets
keeping_degseqGraph rewiring while preserving the degree distribution
knnAverage nearest neighbor degree
laplacian_matrixGraph Laplacian
layout_Graph layouts
layout_as_bipartiteSimple two-row layout for bipartite graphs
layout_as_starGenerate coordinates to place the vertices of a graph in a...
layout_as_treeThe Reingold-Tilford graph layout algorithm
layout.deprecatedDeprecated layout functions
layout.fruchterman.reingold.gridGrid Fruchterman-Reingold layout, this was removed from...
layout_in_circleGraph layout with vertices on a circle.
layout_nicelyChoose an appropriate graph layout algorithm automatically
layout_on_gridSimple grid layout
layout_on_sphereGraph layout with vertices on the surface of a sphere
layout_randomlyRandomly place vertices on a plane or in 3d space
layout.springSpring layout, this was removed from igraph
layout.svdSVD layout, this was removed from igraph
layout_with_dhThe Davidson-Harel layout algorithm
layout_with_drlThe DrL graph layout generator
layout_with_frThe Fruchterman-Reingold layout algorithm
layout_with_gemThe GEM layout algorithm
layout_with_graphoptThe graphopt layout algorithm
layout_with_kkThe Kamada-Kawai layout algorithm
layout_with_lglLarge Graph Layout
layout_with_mdsGraph layout by multidimensional scaling
layout_with_sugiyamaThe Sugiyama graph layout generator
local_scanCompute local scan statistics on graphs
make_Make a new graph
make_bipartite_graphCreate a bipartite graph
make_chordal_ringCreate an extended chordal ring graph
make_clustersCreates a communities object.
make_de_bruijn_graphDe Bruijn graphs
make_empty_graphA graph with no edges
make_from_pruferCreate an undirected tree graph from its Prüfer sequence
make_full_bipartite_graphCreate a full bipartite graph
make_full_citation_graphCreate a complete (full) citation graph
make_full_graphCreate a full graph
make_graphCreate an igraph graph from a list of edges, or a notable...
make_kautz_graphKautz graphs
make_latticeCreate a lattice graph
make_line_graphLine graph of a graph
make_ringCreate a ring graph
make_starCreate a star graph, a tree with n vertices and n - 1 leaves
make_treeCreate tree graphs
matchingMatching
match_verticesMatch Graphs given a seeding of vertex correspondences
max_cardinalityMaximum cardinality search
max_flowMaximum flow in a graph
merge_coordsMerging graph layouts
min_cutMinimum cut in a graph
min_separatorsMinimum size vertex separators
min_st_separatorsMinimum size vertex separators
modularity.igraphModularity of a community structure of a graph
motifsGraph motifs
mstMinimum spanning tree
neighborsNeighboring (adjacent) vertices in a graph
normalizeNormalize layout
norm_coordsNormalize coordinates for plotting graphs
page_rankThe Page Rank algorithm
pathHelper function to add or delete edges along a path
permutePermute the vertices of a graph
pipeMagrittr's pipes
plot.commonDrawing graphs
plot_dendrogram.communitiesCommunity structure dendrogram plots
plot_dendrogram.igraphHRGHRG dendrogram plot
plot.igraphPlotting of graphs
plot.sirPlotting the results on multiple SIR model runs
plus-.igraphAdd vertices, edges or another graph to a graph
power_centralityFind Bonacich Power Centrality Scores of Network Positions
predict_edgesPredict edges based on a hierarchical random graph model
printer_callbackCreate a printer callback function
print.igraphPrint graphs to the terminal
print.igraph.esPrint an edge sequence to the screen
print.igraphHRGPrint a hierarchical random graph model to the screen
print.igraphHRGConsensusPrint a hierarchical random graph consensus tree to the...
print.igraph.vsShow a vertex sequence on the screen
printrBetter printing of R packages
radiusRadius of a graph
random_walkRandom walk on a graph
read_graphReading foreign file formats
realize_degseqCreating a graph from a given degree sequence,...
reciprocityReciprocity of graphs
rep.igraphReplicate a graph multiple times
reverse_edgesReverse edges in a graph
rev.igraph.esReverse the order in an edge sequence
rev.igraph.vsReverse the order in a vertex sequence
rewireRewiring edges of a graph
rglplot3D plotting of graphs with OpenGL
r_palThe default R palette
running_meanRunning mean of a time series
sample_Sample from a random graph model
sample_bipartiteBipartite random graphs
sample_correlated_gnpGenerate a new random graph from a given graph by randomly...
sample_correlated_gnp_pairSample a pair of correlated G(n,p) random graphs
sample_degseqGenerate random graphs with a given degree sequence
sample_dirichletSample from a Dirichlet distribution
sample_dot_productGenerate random graphs according to the random dot product...
sample_fitnessRandom graphs from vertex fitness scores
sample_fitness_plScale-free random graphs, from vertex fitness scores
sample_forestfireForest Fire Network Model
sample_gnmGenerate random graphs according to the G(n,m) Erdős-Rényi...
sample_gnpGenerate random graphs according to the G(n,p) Erdős-Rényi...
sample_grgGeometric random graphs
sample_growingGrowing random graph generation
sample_hierarchical_sbmSample the hierarchical stochastic block model
sample_hrgSample from a hierarchical random graph model
sample_islandsA graph with subgraphs that are each a random graph.
sample_k_regularCreate a random regular graph
sample_last_citRandom citation graphs
sample_motifsGraph motifs
sample_paGenerate random graphs using preferential attachment
sample_pa_ageGenerate an evolving random graph with preferential...
sample_prefTrait-based random generation
sample_sbmSample stochastic block model
sample_seqSampling a random integer sequence
sample_smallworldThe Watts-Strogatz small-world model
sample_spanning_treeSamples from the spanning trees of a graph randomly and...
sample_sphere_surfaceSample vectors uniformly from the surface of a sphere
sample_sphere_volumeSample vectors uniformly from the volume of a sphere
sample_traits_callawayGraph generation based on different vertex types
sample_treeSample trees randomly and uniformly
scan_statScan statistics on a time series of graphs
scgAll-in-one Function for the SCG of Matrices and Graphs
scg_epsError of the spectral coarse graining (SCG) approximation
scg_groupSCG Problem Solver
scg-methodSpectral Coarse Graining
scg_semi_projSemi-Projectors
sequential_palSequential palette
set_edge_attrSet edge attributes
set_graph_attrSet a graph attribute
set_vertex_attrSet vertex attributes
shapesVarious vertex shapes when plotting igraph graphs
similaritySimilarity measures of two vertices
simplifiedConstructor modifier to drop multiple and loop edges
simplifySimple graphs
sirSIR model on graphs
spectrumEigenvalues and eigenvectors of the adjacency matrix of a...
split_join_distanceSplit-join distance of two community structures
st_cutsList all (s,t)-cuts of a graph
st_min_cutsList all minimum (s,t)-cuts of a graph
stochastic_matrixStochastic matrix of a graph
strengthStrength or weighted vertex degree
subcomponentIn- or out- component of a vertex
subgraphSubgraph of a graph
subgraph_centralityFind subgraph centrality scores of network positions
subgraph_isomorphicDecide if a graph is subgraph isomorphic to another one
subgraph_isomorphismsAll isomorphic mappings between a graph and subgraphs of...
sub-.igraphQuery and manipulate a graph as it were an adjacency matrix
sub-sub-.igraphQuery and manipulate a graph as it were an adjacency list
tail_ofTails of the edge(s) in a graph
tkigraphExperimental basic igraph GUI
tkplotInteractive plotting of graphs
topo_sortTopological sorting of vertices in a graph
to_pruferConvert a tree graph to its Prüfer sequence
transitivityTransitivity of a graph
triad_censusTriad census, subgraphs with three vertices
unfold_treeConvert a general graph into a forest
unionUnion of two or more sets
union.igraphUnion of graphs
union.igraph.esUnion of edge sequences
union.igraph.vsUnion of vertex sequences
unique.igraph.esRemove duplicate edges from an edge sequence
unique.igraph.vsRemove duplicate vertices from a vertex sequence
upgrade_graphigraph data structure versions
VVertices of a graph
vertexHelper function for adding and deleting vertices
vertex_attrQuery vertex attributes of a graph
vertex_attr_namesList names of vertex attributes
vertex_attr-setSet one or more vertex attributes
vertex_connectivityVertex connectivity
vertex.shape.pieUsing pie charts as vertices in graph plots
weighted_cliquesFunctions to find weighted cliques, i.e. weighted complete...
which_multipleFind the multiple or loop edges in a graph
which_mutualFind mutual edges in a directed graph
with_edge_Constructor modifier to add edge attributes
with_graph_Constructor modifier to add graph attributes
with_igraph_optRun code with a temporary igraph options setting
without_attrConstrutor modifier to remove all attributes from a graph
without_loopsConstructor modifier to drop loop edges
without_multiplesConstructor modifier to drop multiple edges
with_vertex_Constructor modifier to add vertex attributes
write_graphWriting the graph to a file in some format
igraph documentation built on Aug. 10, 2023, 9:08 a.m.