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