igraph2.0.3 package

Network Analysis and Visualization

is.chordal

Chordality of a graph

is.connected

Connected components of a graph

is.dag

Directed acyclic graphs

is.degree.sequence

Check if a degree sequence is valid for a multi-graph

is.directed

Check whether a graph is directed

is.graphical.degree.sequence

Is a degree sequence graphical?

is.hierarchical

Functions to deal with the result of network community detection

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.multiple

Find the multiple or loop edges in a graph

is.mutual

Find mutual edges in a directed graph

is.named

Named graphs

is.separator

Vertex separators

is.simple

Simple graphs

is.weighted

Weighted graphs

realize_bipartite_degseq

Creating a bipartite graph from two degree sequences, deterministicall...

realize_degseq

Creating a graph from a given degree sequence, deterministically

is_acyclic

Acyclic graphs

is_biconnected

Check biconnectedness

is_bipartite

Checks whether the graph has a vertex attribute called type.

intersection.igraph

Intersection of graphs

intersection.igraph.vs

Intersection of vertex sequences

aaa-igraph-package

The igraph package

add.edges

Add edges to a graph

add.vertex.shape

Various vertex shapes when plotting igraph graphs

add.vertices

Add vertices to a graph

intersection

Intersection of two or more sets

add_edges

Add edges to a graph

add_layout_

Add layout to 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 attachment and agi...

is.bipartite

Checks whether the graph has a vertex attribute called type

aging.barabasi.game

Generate an evolving random graph with preferential attachment and agi...

aging.prefatt.game

Generate an evolving random graph with preferential attachment and agi...

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.connected

Are two vertices adjacent?

are_adjacent

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.directed

Convert between directed and undirected graphs

as.igraph

Conversion to igraph

as.matrix.igraph

Convert igraph objects to adjacency or edge list matrices

as_adj_list

Adjacency lists

as_adjacency_matrix

Convert a graph to an adjacency matrix

as_biadjacency_matrix

Bipartite adjacency matrix of a bipartite graph

as_edgelist

Convert a graph to an edge list

as_graphnel

Convert igraph graphs to graphNEL objects from the graph package

as_ids

Convert a vertex or edge sequence to an ordinary vector

as_incidence_matrix

As incidence matrix

as_long_data_frame

Convert a graph to a long data frame

as_membership

Declare a numeric vector as a membership vector

as_phylo

as_phylo

assortativity.degree

Assortativity coefficient

assortativity.nominal

Assortativity coefficient

assortativity

Assortativity coefficient

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.projection

Project a bipartite graph

bipartite.projection.size

Project a bipartite graph

bipartite.random.game

Bipartite random graphs

bipartite_mapping

Decide whether a graph is bipartite

bipartite_projection

Project a bipartite graph

blockGraphs

Calculate Cohesive Blocks

bonpow

Find Bonacich Power Centrality Scores of Network Positions

c.igraph.es

Concatenate edge sequences

c.igraph.vs

Concatenate vertex sequences

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

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 vertices

centr_eigen_tmax

Theoretical maximum for betweenness centralization

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 vertices

centralization.evcent.tmax

Theoretical maximum for betweenness centralization

centralize

Centralization of a graph

centralize.scores

Centralization of a graph

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 eigenvector of the ...

cluster_leiden

Finding community structure of a graph using the Leiden algorithm of T...

cluster_louvain

Finding community structure by multi-level optimization of modularity

cluster_optimal

Optimal community structure

cluster_spinglass

Finding communities in graphs based on statistical meachanics

cluster_walktrap

Community structure via short random walks

clusters

Connected components of a graph

cocitation

Cocitation coupling

code.length

Functions to deal with the result of network community detection

cohesive.blocks

Calculate Cohesive Blocks

cohesive_blocks

Calculate Cohesive Blocks

communities

Functions to deal with the result of network community detection

compare

Compares community structures using various metrics

complementer

Complementer of a graph

component_wise

Component-wise layout

components

Connected components of a graph

compose

Compose two graphs as binary relations

connect.neighborhood

Neighborhood of graph vertices

consensus_tree

Create a consensus tree from several hierarchical random graph models

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.multiple

Find the multiple or loop edges in a graph

count_automorphisms

Number of automorphisms

count_isomorphisms

Count the number of isomorphic mappings between two graphs

count_motifs

Graph motifs

count_subgraph_isomorphisms

Count the isomorphic mappings between a graph and the subgraphs of ano...

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 detection

decompose.graph

Decompose a graph into components

decompose

Decompose a graph into components

degree.distribution

Degree and degree distribution of the vertices

degree

Degree and degree distribution of the vertices

degree.sequence.game

Generate random graphs with a given degree sequence

delete.edges

Delete edges from a graph

delete.vertices

Delete vertices from a graph

delete_edge_attr

Delete an edge attribute

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

dendPlot

Community structure dendrogram plots

dfs

Depth-first search

diameter

Diameter of a graph

difference.igraph.es

Difference of edge sequences

difference.igraph

Difference of graphs

difference.igraph.vs

Difference of vertex sequences

difference

Difference of two sets

dim_select

Dimensionality selection for singular values using profile likelihood.

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 vertex

eccentricity

Eccentricity of the vertices in a graph

edge.betweenness.community

Community structure detection based on edge betweenness

edge.betweenness

Vertex and edge betweenness centrality

edge.connectivity

Edge connectivity

edge.disjoint.paths

Edge connectivity

edge

Helper function for adding and deleting edges

edge_attr-set

Set one or more edge attributes

edge_attr

Query edge attributes of a graph

edge_attr_names

List names of edge attributes

edge_connectivity

Edge connectivity

edge_density

Graph density

ego

Neighborhood of graph vertices

eigen_centrality

Find Eigenvector Centrality Scores of Network Positions

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.attribute

Query edge attributes of a graph

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

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

getIgraphOpt

Parameters for the igraph package

girth

Girth of a graph

global_efficiency

Efficiency of a graph

gorder

Order (number of vertices) of a graph

graph.adhesion

Edge connectivity

graph.adjacency

Create graphs from adjacency matrices

graph.adjlist

Create graphs from adjacency lists

graph.automorphisms

Number of automorphisms

graph.bfs

Breadth-first search

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.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

graph.graphdb

Load a graph from the graph database for testing graph isomorphism.

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.knn

Average nearest neighbor degree

graph.laplacian

Graph Laplacian

graph.maxflow

Maximum flow in a graph

graph.mincut

Minimum cut in a graph

graph.motifs.est

Graph motifs

graph.motifs.no

Graph motifs

graph.motifs

Graph motifs

graph.neighborhood

Neighborhood of graph vertices

graph.strength

Strength or weighted vertex degree

graph.union

Union of graphs

graph_

Convert object to a graph

graph_attr-set

Set all or some graph attributes

graph_attr

Graph attributes of a graph

graph_attr_names

List names of graph attributes

graph_from_adj_list

Create graphs from adjacency lists

graph_from_adjacency_matrix

Create graphs from adjacency matrices

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 isomorphism.

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_id

Get the id of a graph

graph_version

igraph data structure versions

graphlet_basis

Graphlet decomposition of a graph

graphlets.candidate.basis

Graphlet decomposition of a graph

graphlets.project

Graphlet decomposition of a graph

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)

handle_vertex_type_arg

Common handler for vertex type arguments in igraph functions

harmonic_centrality

Harmonic centrality of vertices

has.multiple

Find the multiple or loop edges in a graph

has_eulerian_path

Find Eulerian paths or cycles in a graph

head_of

Head of the edge(s) in a graph

head_print

Print the only the head of an R object

hrg-methods

Hierarchical random graphs

hrg.consensus

Create a consensus tree from several hierarchical random graph models

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.predict

Predict edges based on a hierarchical random graph model

hrg

Create a hierarchical random graph from an igraph graph

hrg_tree

Create an igraph graph from a hierarchical random graph model

hub.score

Kleinberg's hub and 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-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-minus

Delete vertices or edges from a graph

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

igraph.console

The igraph console

igraph.from.graphNEL

Convert graphNEL objects from the graph package to igraph

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 package

igraph.version

Query igraph's version string

igraph_demo

Run igraph demos, step by step

igraph_options

Parameters for the igraph package

igraph_test

Run package tests

igraph_version

Query igraph's version string

igraphdemo

Run igraph demos, step by step

igraphtest

Run package tests

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

interconnected.islands.game

A graph with subgraphs that are each a random graph.

intersection.igraph.es

Intersection of edge sequences

is_chordal

Chordality of a graph

is_dag

Directed acyclic graphs

is_degseq

Check if a degree sequence is valid for a multi-graph

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_igraph

Is this object an igraph graph?

is_min_separator

Minimal vertex separators

is_named

Named graphs

is_printer_callback

Is this a printer callback?

is_separator

Vertex separators

is_tree

Decide whether a graph is a tree.

is_weighted

Weighted 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 graphs

ivs

Independent vertex sets

k.regular.game

Create a random regular graph

k_shortest_paths

Find the kk shortest paths between two vertices

keeping_degseq

Graph rewiring while preserving the degree distribution

knn

Average nearest neighbor degree

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.auto

Choose an appropriate graph layout algorithm automatically

layout.bipartite

Simple two-row layout for bipartite graphs

layout.davidson.harel

The Davidson-Harel layout algorithm

layout.deprecated

Deprecated layout functions

layout.drl

The DrL graph layout generator

layout.fruchterman.reingold.grid

Grid Fruchterman-Reingold layout, this was removed from igraph

layout.gem

The GEM layout algorithm

layout.graphopt

The graphopt layout algorithm

layout.grid

Simple grid layout

layout.mds

Graph layout by multidimensional scaling

layout.merge

Merging graph layouts

layout.norm

Normalize coordinates for plotting graphs

layout.spring

Spring layout, this was removed from igraph

layout.star

Generate coordinates to place the vertices of a graph in a star-shape

layout.sugiyama

The Sugiyama graph layout generator

layout.svd

SVD layout, this was removed from igraph

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 star-shape

layout_as_tree

The Reingold-Tilford graph layout algorithm

layout_in_circle

Graph layout with vertices on a circle.

layout_nicely

Choose an appropriate graph layout algorithm automatically

layout_on_grid

Simple grid layout

layout_on_sphere

Graph layout with vertices on the surface of a sphere

layout_randomly

Randomly place vertices on a plane or in 3d space

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 eigenvector of the ...

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 graph

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

match_vertices

Match Graphs given a seeding of vertex correspondences

matching

Matching

max_cardinality

Maximum cardinality search

max_flow

Maximum flow in a graph

maxcohesion

Calculate Cohesive Blocks

maximal.cliques.count

Functions to find cliques, i.e. complete subgraphs in a graph

maximal.cliques

Functions to find cliques, i.e. complete subgraphs in a graph

maximal.independent.vertex.sets

Independent vertex sets

maximum.bipartite.matching

Matching

maximum.cardinality.search

Maximum cardinality search

merge_coords

Merging graph layouts

min_cut

Minimum cut in a graph

min_separators

Minimum size vertex separators

min_st_separators

Minimum size vertex separators

minimal.st.separators

Minimum size vertex separators

minimum.size.separators

Minimum size vertex separators

minimum.spanning.tree

Minimum spanning tree

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 modularity

neighborhood.size

Neighborhood of graph vertices

neighbors

Neighboring (adjacent) vertices in a graph

no.clusters

Connected components of a graph

norm_coords

Normalize coordinates for plotting graphs

normalize

Normalize layout

optimal.community

Optimal community structure

page.rank

The Page Rank algorithm

page_rank

The Page Rank algorithm

path.length.hist

Shortest (directed or undirected) paths between vertices

path

Helper function to add or delete edges along a path

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.igraph

Plotting of graphs

plot.sir

Plotting the results on multiple SIR model runs

plot_dendrogram.communities

Community structure dendrogram plots

plot_dendrogram.igraphHRG

HRG dendrogram plot

plotHierarchy

Calculate Cohesive Blocks

plus-.igraph

Add vertices, edges or another graph to a graph

power.law.fit

Fitting a power-law distribution function to discrete data

power_centrality

Find Bonacich Power Centrality Scores of Network Positions

predict_edges

Predict edges based on a hierarchical random graph model

preference.game

Trait-based random generation

print.igraph.es

Print an edge sequence to the screen

print.igraph

Print graphs to the terminal

print.igraph.vs

Show a vertex sequence on the screen

print.igraphHRG

Print a hierarchical random graph model to the screen

print.igraphHRGConsensus

Print a hierarchical random graph consensus tree to the screen

printer_callback

Create a printer callback function

r_pal

The default R palette

radius

Radius of a graph

random_walk

Random walk on a graph

read.graph

Reading foreign file formats

read_graph

Reading foreign file formats

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

rev.igraph.es

Reverse the order in an edge sequence

rev.igraph.vs

Reverse the order in a vertex sequence

reverse_edges

Reverse edges in a graph

rewire

Rewiring edges of a graph

rglplot

3D plotting of graphs with OpenGL

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_correlated_gnp

Generate a new random graph from a given graph by randomly adding/remo...

sample_correlated_gnp_pair

Sample a pair of correlated G(n,p)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 graph model

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)G(n,m) Erdős-Rényi model

sample_gnp

Generate random graphs according to the G(n,p)G(n,p) Erdős-Rényi model

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 attachment and agi...

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 uniformly

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.attribute

Set edge attributes

set.graph.attribute

Set a graph attribute

set.vertex.attribute

Set vertex attributes

set_edge_attr

Set edge attributes

set_graph_attr

Set a graph attribute

set_vertex_attr

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 detection

similarity

Similarity measures of two vertices

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 graph

spinglass.community

Finding communities in graphs based on statistical meachanics

split_join_distance

Split-join distance of two community structures

st_cuts

List all (s,t)-cuts of a graph

st_min_cuts

List all minimum (s,t)(s,t)-cuts of a graph

static.fitness.game

Random graphs from vertex fitness scores

static.power.law.game

Scale-free random graphs, from vertex fitness scores

stCuts

List all (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

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

subcomponent

In- or out- component of a vertex

subgraph.centrality

Find subgraph centrality scores of network positions

subgraph

Subgraph of a graph

subgraph_centrality

Find subgraph centrality scores of network positions

subgraph_isomorphic

Decide if a graph is subgraph isomorphic to another one

subgraph_isomorphisms

All isomorphic mappings between a graph and subgraphs of another graph

tail_of

Tails of the edge(s) in a graph

tkigraph

Experimental basic igraph GUI

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

Interactive plotting of graphs

tkplot.reshape

Interactive plotting of graphs

tkplot.rotate

Interactive plotting of graphs

tkplot.setcoords

Interactive plotting of graphs

to_prufer

Convert a tree graph to its Prüfer sequence

topo_sort

Topological sorting of vertices in a graph

topological.sort

Topological sorting of vertices in a graph

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.igraph.es

Union of edge sequences

union.igraph

Union of graphs

union.igraph.vs

Union of vertex sequences

union

Union of two or more sets

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.connectivity

Vertex connectivity

vertex.disjoint.paths

Vertex connectivity

vertex

Helper function for adding and deleting vertices

vertex.shape.pie

Using pie charts as vertices in graph plots

vertex.shapes

Various vertex shapes when plotting igraph graphs

vertex_attr-set

Set one or more vertex attributes

vertex_attr

Query vertex attributes of a graph

vertex_attr_names

List names of vertex attributes

vertex_connectivity

Vertex connectivity

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 complete subg...

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

with_vertex_

Constructor modifier to add vertex attributes

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

write.graph

Writing the graph to a file in some format

write_graph

Writing the graph to a file in some format

Routines for simple graphs and network analysis. It can handle large graphs very well and provides functions for generating random and regular graphs, graph visualization, centrality methods and much more.

  • Maintainer: Kirill Müller
  • License: GPL (>= 2)
  • Last published: 2024-03-13