Contents

1 Introduction

Proteomic studies typically generate a massive list of proteins being identified within a specific tissue, compartment or cell type, often accompanied by additional qualitative and/or quantitative information. Conversion of these data into meaningful biological insight requires processing in several stages to identify possible structural and/or functional dependencies.

One of the most popular ways of representing proteomic data is a protein-protein interaction network, which allows to study its topology and how it correlates with functional annotation mapped onto the network.

Many existing packages support different steps of the network building and analysis process, but few packages combine network analysis methodology into a single coherent pipeline.

We designed BioNAR to support a range of network analysis functionality, complementing existing R packages and filling the methodological gaps necessary to interrogate biomedical networks with respect to functional and disease domains. For that purpose, we do not implement network reconstruction directly (unless for synaptic networks), as other tools such as Cytoscape and Network Analyst do this already. Rathher, we provide a detailed topologically-based network analysis package, enabling the researcher to load networks generated from the lab’s own meta-data, thus making the tool as widely applicable and flexible as possible. We also provide a synaptic proteome network of our own for validation.

2 Overview of capabilities

The BioNAR’s pipeline starts with importing the graph of interest (typically built from nodes/proteins and edges/PPI interactions), and annotating its vertices with available metadata [annotate_vertex].

This is followed by the analysis of general network properties, such as estimating a network’s “scale-free” property. For this we used the R “PoweRlaw” package (version 0.50.0) (Gillespie, 2015) [FitDegree] and a network entropy analysis (Teschendorff et al, 2014) [getEntopy].

The package allows estimation of the main network vertex centrality measures: degree, betweenness centrality, clustering coefficient, semilocal centrality, mean shortest path, page rank, and standard deviation of the shortest path. Values for centrality values measures can be added as vertex attributes [calcCentrality] or returned as an R matrix [getCentralityMatrix], depending on user’s preferences. Any other vertex meta-data, which can be represented in matrix form, can also be stored as a vertex attribute.

To compare observed networks vertex centrality values against those of equivalently sized but randomised graphs, we support three varying randomisation models including G(n,p) Erdos-Renyi model , Barabasi-Albert model, and new random graph from a given graph by randomly adding/removing edges [getRandomGraphCentrality].

Additionally, to allow comparison of networks with different structures, we implemented normalized modularity measure (Parter et al., 2007, Takemoto, 2012, Takemoto, 2013, Takemoto and Borjigin, 2011)[normModularity].

BioNAR then proceeds to analyse the network’s community structure, which can be performed via nine different clustering algorithms, simultaneously [calcAllClustering] or with a chosen algorithm [calcClustering], community membership being stored as a vertex attribute. In situations where the network is dense and clusters are large and barely tractable, reclustering can be applied [calcReclusterMatrix]. The obtained community structure can be visualized with [layoutByCluster], and communiities further tested for robustness [getRobustness] by comparing against randomised networks. As a result, a consensus matrix can be estimated [makeConsensusMatrix], which is needed for the next step -identifying the “influential” or “bridging” proteins (Nepusz et al., 2008).

For this, we enabled a function for calculating the “bridgeness” [getBridgeness] metric, which takes into account the probability a vertex to belongs to different communities [getBridgeness], such that a vertex can be ranked under assumption the higher its community membership the more influence it has to the network topology and signaling (Han et al., 2004). “Bridgeness” can be plotted against any other centrality measure, e.g. semi-local centrality (plot is implemented), to enable useful indication of vertex (protein) importance within the network topology.

To provide a perspective of the molecular signature of multiple diseases (or biological functions) and how they might interact or overap at the network level, we implemented a disease-disease overlap analysis by measuring the mean shortest distance for each disease (⟨d⟩), using the shortest distance between each gene-disease association (GDA) to its next nearest GDA neighbor (Menche et al., 2015) [calcDiseasePairs], [runPermDisease] to be used for obtaining significance values. In the case example of the presynaptic network we found a set of neurological disorders to overlap with a high significance, e.g. AD-PD, SCH-BP, ASD-ID, and, indeed, their comorbidity was confirmed by the literature. Note that while developed for disease-disease correlation, the analysis can be performed using any in-house vertex meta-data, including biological function terms.

To study the distribution of the specific annotation(s) over a clustered graph (typically disease of biologial process/function), we enabled overrepresentation analysis [clusterORA], which helps identify the network communities enriched for specific function or disease, or any other annotation.

The case study illustrates the package functionality for the protein-protein interaction network for the presynaptic compartment of the synapse generated from Synaptic proteome database (Sorokina et al., 2021) with Synaptome.db package. The network has 1073 vertices and 6620 edges, step by step analysis is shown below.

3 Build the network

BioNAR allows building a network from a data frame, where the rows correspond to the edges of the graph; alternatively for our synaptic proteome exemple, a list of vertices (genes) is needed, for which the information will be retrieved from SynaptomeDB package.

3.1 Build a network from a given data frame

The command listed below builds a graph from provided data frame, simplifies the graph (removing multiple edges and loops) and return its MCC (maximum connected component)

file <- system.file("extdata", "PPI_Presynaptic.csv", package = "BioNAR")
tbl <- read.csv(file, sep="\t")
head(tbl)
#>   entA  entB We
#> 1  273  1759  1
#> 2  273  1785  1
#> 3  273 26052  1
#> 4  273   824  1
#> 5  273   161  1
#> 6  273  1020  1
gg <- buildNetwork(tbl)
summary(gg)
#> IGRAPH b75cee1 UN-- 1780 6620 -- 
#> + attr: name (v/c)

3.2 Use a predifined network

Any predefined network stored as a graph file (e.g. .gml, .graphml) can be loaded for further analysis using Igraph’s functionality.

file <- system.file("extdata", "PPI_Presynaptic.gml", package = "BioNAR")
gg1 <- igraph::read_graph(file,format="gml")
summary(gg1)
#> IGRAPH 508178e UN-- 2169 8673 -- 
#> + attr: id (v/n), name (v/c), GeneName (v/c), UniProt (v/c), louvain
#> | (v/n), TopOntoOVG (v/c), TopOntoOVGHDOID (v/c)

4 Annotate the nodes with node attributes

As soon as the graph is loaded it can be annotated with any relevant annotations, such as protein names [annotateGeneNames], functionality [annotateGOont], disease associations [annotateTopOntoOVG], or any customized annotation set [annotate_vertex {BioNAR}]. We also provide two functional annotations for synaptic graphs based on published synaptic functional studies ([annotateSCHanno], and [annotatePresynaptic].

4.1 Gene name

Adding gene names to vertices.

gg<-annotateGeneNames(gg)
summary(gg)
#> IGRAPH b75cee1 UN-- 1780 6620 -- 
#> + attr: name (v/c), GeneName (v/c)
head(V(gg))
#> + 6/1780 vertices, named, from b75cee1:
#> [1] 273   6455  1759  1785  26052 2923
head(V(gg)$GeneName)
#> [1] "AMPH"   "SH3GL1" "DNM1"   "DNM2"   "DNM3"   "PDIA3"

4.2 Diseases

Adding diseases associations to genes linked to Human Disease Ontology (HDO) terms extracted from the package (topOnto.HDO.db)[https://github.com/hxin/topOnto.HDO.db].

afile<-system.file("extdata", "flatfile_human_gene2HDO.csv", package = "BioNAR")
dis <- read.table(afile,sep="\t",skip=1,header=FALSE,strip.white=TRUE,quote="")
gg <- annotateTopOntoOVG(gg, dis)
summary(gg)
#> IGRAPH b75cee1 UN-- 1780 6620 -- 
#> + attr: name (v/c), GeneName (v/c), TopOnto_OVG (v/c),
#> | TopOnto_OVG_HDO_ID (v/c)

4.4 Presynaptic functional annotation

Adding the presynaptic genes functional annotation derived from Boyken at al. (2013) doi:10.1016/j.neuron.2013.02.027.

sfile<-system.file("extdata", "PresynAn.csv", package = "BioNAR")
pres <- read.csv(sfile,skip=1,header=FALSE,strip.white=TRUE,quote="")
sgg <- annotatePresynaptic(gg, pres)
summary(sgg)

4.5 Functional annotation with Gene Ontology (GO)

GO annotation is specifically supported with the function [annotateGOont]:


ggGO <- annotateGOont(gg)
#however, functionality from GO: BP, MF,CC can be added

sfile<-system.file("extdata", "flatfile.go.BP.csv", package = "BioNAR")
goBP <- read.table(sfile,sep="\t",skip=1,header=FALSE,strip.white=TRUE,quote="")
sgg <- annotateGoBP(gg, goBP)
summary(sgg)
#> IGRAPH b75cee1 UN-- 1780 6620 -- 
#> + attr: name (v/c), GeneName (v/c), TopOnto_OVG (v/c),
#> | TopOnto_OVG_HDO_ID (v/c), GO_BP_ID (v/c), GO_BP (v/c)

sfile<-system.file("extdata", "flatfile.go.MF.csv", package = "BioNAR")
goMF <- read.table(sfile,sep="\t",skip=1,header=FALSE,strip.white=TRUE,quote="")
sgg <- annotateGoMF(gg, goMF)
summary(sgg)
#> IGRAPH b75cee1 UN-- 1780 6620 -- 
#> + attr: name (v/c), GeneName (v/c), TopOnto_OVG (v/c),
#> | TopOnto_OVG_HDO_ID (v/c), GO_MF_ID (v/c), GO_MF (v/c)

sfile<-system.file("extdata", "flatfile.go.CC.csv", package = "BioNAR")
goCC <- read.table(sfile,sep="\t",skip=1,header=FALSE,strip.white=TRUE,quote="")
sgg <- annotateGoCC(gg, goCC)
summary(sgg)
#> IGRAPH b75cee1 UN-- 1780 6620 -- 
#> + attr: name (v/c), GeneName (v/c), TopOnto_OVG (v/c),
#> | TopOnto_OVG_HDO_ID (v/c), GO_CC_ID (v/c), GO_CC (v/c)

5 Estimate vertex centrality measures

5.1 Estimate centrality measures with values added as vertex attributes.

BioNAR supports centrality measures as following: * DEG - degree, * BET - betweenness, * CC - clustering coefficient, * SL - semilocal centrality, * mnSP - mean shortest path, * PR - page rank, * sdSP - standard deviation of the shortest path. These are saved as vertex atrtributes.

gg <- calcCentrality(gg)
summary(gg)
#> IGRAPH b75cee1 UN-- 1780 6620 -- 
#> + attr: name (v/c), GeneName (v/c), TopOnto_OVG (v/c),
#> | TopOnto_OVG_HDO_ID (v/c), DEG (v/n), BET (v/n), CC (v/n), SL (v/n),
#> | mnSP (v/n), PR (v/n), sdSP (v/c)

5.2 Get vertex centralities as a matrix.

Instead of saving entrality centrality values on the graph, e.g. to provide different names for the vertex centrality attributes, they can be obtained in a matrix form:

mc <- getCentralityMatrix(gg)
head(mc)
#>      ID DEG        BET         CC     SL  mnSP           PR  sdSP
#> 1   273  12   833.2335 0.10606061  44656 3.424 0.0007855514 0.707
#> 2  6455  22  5444.7102 0.08225108 170211 2.955 0.0013374528 0.683
#> 3  1759  16  1744.9317 0.21666667 150771 3.062 0.0009619764 0.687
#> 4  1785  27 10994.5087 0.07122507 218717 2.890 0.0016436995 0.701
#> 5 26052   6   291.1377 0.13333333  55060 3.503 0.0004051298 0.743
#> 6  2923   7  1225.7092 0.09523810  55104 3.391 0.0005312439 0.758

5.3 Get the centrality measures for random graph

Sometimes one needs to compare the graph properties of the the properties of an the observed network to randomised networks of a similar size. The BioNAR command below provides three ways of generating randomization, randomised networks given an observed network including: G(n,p) Erdos-Renyi model, Barabasi-Albert model and new random graph from a given graph by randomly adding/removing edges.

{r}
ggrm <- getRandomGraphCentrality(sgg, type = c("cgnp"))
head(ggrm)

5.4 Power law fit

To examine a network’s underlying structure (i.e. not random), one can test a network’s degree distribution for evidence of scale-free structure and compare this against randomised network models. For this we used the R “PoweRlaw” package (version 0.50.0) (Gillespie, 2015). For the case study, i.e.  our presynaptic PPI network, we found evidence for disassortative mixing (Newman, 2002), i.e. a preference for high-degree genes to attach to low-degree gene(presynaptic: -0.16).

pFit <- fitDegree( as.vector(igraph::degree(graph=gg)),threads=1,Nsim=5,
                    plot=TRUE,WIDTH=2480, HEIGHT=2480)

5.5 Get entropy rate

Evidence for scale-free structure can also be tested by performing a perturbation analysis of each of the network’s vertices. In this analysis each protein is being perturbed through over-expression (red) and under-expression (green), with the global graph entropy rate (SR) after each proteins perturbation being plotted against the log of the proteins degree, as shown at the plot below. In our case study of the presynaptic PPI network we observe a bi-modal response, between gene over-expression and degree, and opposing bi-phasic response relative to over/under-expression between global entropy rate and degree. This type of bi-modal, bi-phasic behaviour has been observed only in networks with scale-free or approximate scale-free topology (Teschendorff et al, 2014).

ent <- getEntropyRate(gg)
ent
#> $maxSr
#> [1] 3.822764
#> 
#> $SRo
#> [1] 2.639026
SRprime <- getEntropy(gg, maxSr = NULL)
head(SRprime)
#>   ENTREZ.ID GENE.NAME DEGREE        UP      DOWN
#> 1       273      AMPH     12 0.6877989 0.6903153
#> 2      6455    SH3GL1     22 0.6884665 0.6899068
#> 3      1759      DNM1     16 0.6892206 0.6899577
#> 4      1785      DNM2     27 0.6896328 0.6895775
#> 5     26052      DNM3      6 0.6891432 0.6902969
#> 6      2923     PDIA3      7 0.6888827 0.6903132
plotEntropy(SRprime, subTIT = "Entropy", SRo = ent$SRo, maxSr = ent$maxSr)

5.6 Get modularity. Normalised modularity.

Normalised modularity (Qm) allows the comparison of networks with varying structure. Qm based on the previous studies by Parter et al., 2007, Takemoto, 2012, Takemoto, 2013, Takemoto and Borjigin, 2011, which was defined as:

\[Qm = \frac{Q_{real}-Q_{rand}}{Q_{max}-Q_{rand}}\]

Where \(Q_{real}\) is the network modularity of a real-world signaling network and, \(Q_{rand}\) is the average network modularity value obtained from 10,000 randomized networks constructed from its real-world network. \(Q_{max}\) was estimated as: \[Q_{max}=1 − \frac{1}{M}\], where \(M\) is the number of modules in the real network.

Randomized networks were generated from a real-world network using the edge-rewiring algorithm (Maslov and Sneppen, 2002).

nm<-normModularity(gg,alg='louvain')
nm
#> [1] 0.0268367

6 Clustering

Clustering, or community detection, in networks has been well studied in the field of statistical physics with particular attention to methods developed for social science networks. The underlying assumption(s) of what makes a community in social science, translates remarkably well to what we think of as a community (sub-complex, module or cluster) in PPI networks. The possible algorithms of choice implemented in BioNAR are: * “lec”(‘Leading-Eigenvector, Newman, 2006), * “wt”(Walktrap, Pons & Latapy, 2006), * “fc”(Fast-Greedy Community’ algorithm, Clauset et al., 2004), * “infomap” (InfoMAP, Rosvall et al., 2007; Rosvall et al., 2010), * “louvain” (Louvain, Blondel et al., 2008), * “sgG1”, “sgG2”, “sgG5”(SpinGlass, Reichardt & Bornholdt). For each algorithm of interest the community membership can be obtained with'calcMembership command. All algorithm implementations, apart from Spectral were performed using the publicly available R package igraph (Csardi & Nepusz, 2006) (R version 3.4.2, igraph version 1.1.2). Parameters used in the fc, lec, sg, wt and lourvain algorithms were chosen as to maximise the measure Modularity (Newman & Girvan, 2004); infomap seeks the optimal community structure in the data by maximising the objective function called the Minimum Description Length (Rissanen, 1978; Grwald et al., 2005)

# choose one algorithm from the list
alg = "louvain"
mem <- calcMembership(gg, alg)
pander(head(mem))
names membership
273 1
6455 1
1759 1
1785 1
26052 1
2923 2

Due to internal random initialisation consecutive invocation of the same algorithm could produce slightly different community structures:

mem2 <- calcMembership(gg, alg)
idx<-match(mem$names,mem2$names)
idnx<-which(mem$membership!=mem2$membership[idx])
pander(head(cbind(mem[idnx,],mem2[idx[idnx],])))
  names membership names membership
7 22808 3 22808 1
12 22895 4 22895 3
19 351 4 351 3
20 10971 7 10971 1
21 53616 7 53616 1
23 7531 7 7531 1

To avoid inconsistency in downstream analysis we provide two additional functions calcClustering and calcAllClustering that use calcMembership to calculate community memberships and store them within the graph vertices attributes named after the algorithm. They also calculate modularity values and store them as graph vertex attributes named after the clustering algorithm. The difference between calcClustering and calcAllClustering is that calcAllClusteringallows to calculate memberships for all clustering algorithms simultaneously (may take time), and store them as graph vertices attributes, while calcClusteringcommand will work for a specific algorithm.

gg <- calcClustering(gg, alg)
summary(gg)
#> IGRAPH b75cee1 UN-- 1780 6620 -- 
#> + attr: louvain (g/n), name (v/c), GeneName (v/c), TopOnto_OVG (v/c),
#> | TopOnto_OVG_HDO_ID (v/c), DEG (v/n), BET (v/n), CC (v/n), SL (v/n),
#> | mnSP (v/n), PR (v/n), sdSP (v/c), louvain (v/c)

Comminity membership data could be obtained from the graph vertex attribute:

mem.df<-data.frame(names=V(gg)$name,membership=as.numeric(V(gg)$louvain))

To compare different clustering algorithms,a summary matrix can be calculated with the following properties: 1. maximum Modularity obtained (mod), 2. number of detected communities (C), 3. the number of communities with size (Cn1) equal to 1, 4. the number of communities >= 100 (Cn100), 5. the fraction of edges lying between communities (mu), 6. the size of the smallest community (Min. C), 7. the size of the largest community (Max. C), 8. the average ( Mean C), median (Median C), 9. first quartile (1st Qu. C), and 10. third quartile (3rd Qu. C) of the community size.

ggc <- calcAllClustering(gg)
m<-clusteringSummary(ggc,att=c('lec','wt','fc',
                                'infomap','louvain',
                                'sgG1','sgG2','sgG5'))
pander(m)
Table continues below
  N mod C Cn1 Cn100 mu Min. C 1st Qu. C
lec 2169 0.2029 2 0 2 0.2163 552 818.2
wt 2169 0.3602 231 116 4 0.4874 1 1
fc 2169 0.4382 26 0 5 0.3682 3 3.25
infomap 2169 0.4179 159 0 2 0.5449 2 5
louvain 2169 0.4656 15 0 9 0.4313 22 77.5
sgG1 2169 0.4755 34 0 7 0.4017 2 4
sgG2 2169 0.4596 44 0 6 0.4948 3 16.25
sgG5 2169 0.392 97 0 0 0.5909 2 13
  Median C Mean C 3rd Qu. C Max. C
lec 1084 1084 1351 1617
wt 1 9.39 3 594
fc 8 83.42 31 475
infomap 9 13.64 13 181
louvain 152 144.6 205.5 290
sgG1 7.5 63.79 73.75 361
sgG2 44 49.3 69.25 163
sgG5 20 22.36 28 82

It is often useful to be able to visualize clusters of the graph. The simplest way to do this is to color each cluster uniquely and plot the graph:

palette <- distinctColorPalette(max(as.numeric(mem.df$membership)))
plot(gg,vertex.size=3,layout=layout_nicely,
        vertex.label=NA,
        vertex.color=palette[as.numeric(mem.df$membership)],
        edge.color='grey95')
legend('topright',legend=names(table(mem.df$membership)),
        col=palette,pch=19,ncol = 2)

On the plot we can see some distinctive clusters but most verices are indistinguishable within the central part of the plot. So we could layout graph clusterwise:

lay<-layoutByCluster(gg,mem.df,layout = layout_nicely)
plot(gg,vertex.size=3,layout=lay,
        vertex.label=NA,
        vertex.color=palette[as.numeric(mem.df$membership)],
        edge.color='grey95')
legend('topright',legend=names(table(mem.df$membership)),
        col=palette,pch=19,ncol = 2)

It is also possible to visualize the interaction between communities:

idx<-match(V(gg)$name,mem.df$names)
cgg<-getCommunityGraph(gg,mem.df$membership[idx])
D0 = unname(degree(cgg))
plot(cgg, vertex.size=sqrt(V(cgg)$size), vertex.cex = 0.8,
vertex.color=round(log(D0))+1,layout=layout_with_kk,margin=0)

6.0.1 Reclustering

Reclustering a clustered graph using the same, or different, clustering algorithm:

remem<-calcReclusterMatrix(gg,mem.df,alg,10)
head(remem)
#>   names membership recluster
#> 1   273          1         1
#> 2  6455          1         1
#> 3  1759          1         1
#> 4  1785          1         1
#> 5 26052          1         1
#> 6  2923          2         9

And we can apply second order clustering layout:

lay<-layoutByRecluster(gg,remem,layout_nicely)
plot(gg,vertex.size=3,layout=lay,
        vertex.label=NA,
        vertex.color=palette[as.numeric(mem.df$membership)],
        edge.color='grey95')
legend('topright',legend=names(table(mem.df$membership)),
        col=palette,pch=19,ncol = 2)

6.1 Consensus matrix

To assess the robustness of obtained clusters, a randomization study can be performed, which applies the same clustering algorithm to N perturbed networks. The clustering results are returned as a consensus matrix where each matrix elements is assigned the frequency with which a pair of nodes vertices is found in the same cluster.

Where ‘alg’ gives the name of the clustering algorithm, ‘type’ the sampling scheme (1 sample edges, and 2 sample verices) used, ‘mask’ the percentage of edges or vertices to mask, and ‘reclust’ whether reclustering should be performed on the community set found, ‘Cnmin’ minimum cluster size and ‘Cnmax’ the maximum cluster size above which reclustering will be preformed (if reClust=TRUE).

#Build consensus matrix for louvain clustering
conmat <- makeConsensusMatrix(gg, N=5,
                                alg = alg, type = 2, 
                                mask = 10,reclust = FALSE, 
                                Cnmax = 10)

For the sake of timing we use only five randomisation rounds, for the real analysis you should use at least 500.

##Consensus matrix value distribution

Consensus matrix values can be visualised in the following way:

steps <- 100
Fn  <- ecdf(conmat[lower.tri(conmat)])
X<-seq(0,1,length.out=steps+1)
cdf<-Fn(X)
dt<-data.frame(cons=X,cdf=cdf)
ggplot(dt,aes(x=cons,y=cdf))+geom_line()+
        theme(            
        axis.title.x=element_text(face="bold",size=rel(2.5)),
        axis.title.y=element_text(face="bold",size=rel(2.5)),
        legend.title=element_text(face="bold",size=rel(1.5)),
        legend.text=element_text(face="bold",size=rel(1.5)),
        legend.key=element_blank())+
    theme(panel.grid.major = element_line(colour="grey40",size=0.2),
            panel.grid.minor = element_line(colour="grey40",size=0.1),
            panel.background = element_rect(fill="white"),
            panel.border = element_rect(linetype="solid",fill=NA))

6.2 Cluster robustness

Cluster robustness assesses the robustness of obtained clusters and can help evaluate the “goodness” of a chosen clustering algorithm.

clrob<-getRobustness(gg, alg = alg, conmat)
pander(clrob)
alg C Cn Crob CrobScaled
louvain 1 207 0.08989 0.2527
louvain 2 207 0.08691 0.2057
louvain 3 272 0.0846 0.1692
louvain 4 49 0.09624 0.3531
louvain 5 194 0.08547 0.183
louvain 6 172 0.09069 0.2653
louvain 7 149 0.07819 0.06795
louvain 8 151 0.09276 0.2981
louvain 9 150 0.09818 0.3837
louvain 10 52 0.09437 0.3235
louvain 11 43 0.08597 0.1909
louvain 12 45 0.07389 0
louvain 13 30 0.1372 1
louvain 14 59 0.08478 0.1721

7 Bridgeness

Bridging proteins are known to interact with many neighbours simultaneously, organise function inside the communities they belong to, but also affect/influence other communities in the network (Nepusz et al., 2008). Bridgeness can be estimated from the consensus clustering matrix estimated above and vertex degree to calculate the vertex’s community membership, i.e.  the probability a specific vertex belongs to every community obtained by a given clustering algorithm.

The Bridgeness measure lies between 0 - implying a vertex clearly belongs in a single community, and 1 - implying a vertex forms a ‘global bridge’ across every community with the same strength.

br<-getBridgeness(gg,alg = alg,conmat)
pander(head(br))
ID GENE.NAME BRIDGENESS.louvain
273 AMPH 0.1623
6455 SH3GL1 0.2511
1759 DNM1 0.1686
1785 DNM2 0.3548
26052 DNM3 0.1419
2923 PDIA3 0.5553
gg<-calcBridgeness(gg,alg = alg,conmat)
vertex_attr_names(gg)
#>  [1] "name"               "GeneName"           "TopOnto_OVG"       
#>  [4] "TopOnto_OVG_HDO_ID" "DEG"                "BET"               
#>  [7] "CC"                 "SL"                 "mnSP"              
#> [10] "PR"                 "sdSP"               "louvain"           
#> [13] "BRIDGENESS.louvain"

7.1 Bridgeness plot

Semi-local centrality measure (Chen et al., 2011) also lies between 0 and 1 indicating whether protein is important globally or locally. By plotting Bridgeness against semi-local centrality we can categorises the influence each protein found in our network has on the overall network structure: * Region 1, proteins having a ‘global’ rather than ‘local’ influence in the network (also been called bottle-neck bridges, connector or kinless hubs (0<Sl<0.5; 0.5<Br<1). * Region 2, proteins having ‘global’ and ‘local’ influence (0.5<Sl<1, 0.5<Br<1). * Region 3, proteins centred within the community they belong to, but also communicating with a few other specific communities (0<Sl<0.5; 0.1<Br<0.5). * Region 4, proteins with ‘local’ impact , primarily within one or two communities (local or party hubs, 0.5<Sl<1, 0<Br<0.5).

g<-plotBridgeness(gg,alg = alg,
               VIPs=c('8495','22999','8927','8573',
                      '26059','8497','27445','8499'),
               Xatt='SL',
               Xlab = "Semilocal Centrality (SL)",
               Ylab = "Bridgeness (B)",
               bsize = 3,
               spsize =7,
               MainDivSize = 0.8,
               xmin = 0,
               xmax = 1,
               ymin = 0,
               ymax = 1,
               baseColor="royalblue2",
               SPColor="royalblue2")
g

#Interactive view of bridgeness plot

library(plotly)
g<-plotBridgeness(gg,alg = alg,
               VIPs=c('8495','22999','8927','8573',
                      '26059','8497','27445','8499'),
               Xatt='SL',
               Xlab = "Semilocal Centrality (SL)",
               Ylab = "Bridgeness (B)",
               bsize = 1,
               spsize =2,
               MainDivSize = 0.8,
               xmin = 0,
               xmax = 1,
               ymin = 0,
               ymax = 1,
               baseColor="royalblue2",
               SPColor="royalblue2")
ggplotly(g)

8 Disease/annotation pairs

Given that Disease associated genes are connected within the graph, the common question is to check whether the networks for two different diseases are overlapping, which may indicate the common molecular mechanisms. Same is valid for any pair of annotations, e.g. one would ask if two different biological functions are related.

To address this question, we utilise the algorithm from Menche et al, which estimates the minimal shortest paths between two distinct annotations and compares this to the randomly annotated graph.

Below example shows the estimation of disease separation for the following diseases: DOID:10652 (Alzheimer’s_disease), (bipolar_disorder), DOID:12849 (autistic_disorder), DOID:1826 (epilepsy). Command calcDiseasePairs quickly estimates the two annotation separation on the graph and compares it with one randomly reannotated graph. This could be used for initial guess of the relationships between the annotations.

To assess the significance of the obtained separation values the command runPermDisease should be used, where the user can specify the number of permutations. TExecuting this command, which will take time depending of the number of permutations, returns table with of p-values, adjusted p-values, q-values and Bonferroni test for each disease-disease pair.

p <- calcDiseasePairs(
    gg,
    name = "TopOnto_OVG_HDO_ID",
    diseases = c("DOID:10652","DOID:3312"),
    permute = "r"
)
pander(p$disease_separation)
  DOID:10652 DOID:3312
DOID:10652 0 -0.0464
DOID:3312 NA 0

r <- runPermDisease(
    gg,
    name = "TopOnto_OVG_HDO_ID",
    diseases = c("DOID:10652","DOID:3312"),
    Nperm = 100,
    alpha = c(0.05, 0.01, 0.001)
)

pander(r$Disease_overlap_sig)
Table continues below
HDO.ID.A N.A HDO.ID.B N.B sAB Separated Overlap zScore
DOID:10652 259 DOID:10652 259 0 . . 0
DOID:10652 259 DOID:3312 127 -0.2495 . YES -1.999
DOID:3312 127 DOID:3312 127 0 . . 0
pvalue Separation/Overlap.than.chance Bonferroni p.adjusted q-value
1 larger . 1 1
0.04558 Smaller . 0.2507 0.1367
1 larger . 1 1

8.1 Cluster overrepresentation

To identify the clusters with overrepresented function or disease we introduced the function which calculates the overrepesentation (enrichment for specified annotation). Based on R package fgsea.

ora <- clusterORA(gg, alg, name = 'TopOnto_OVG_HDO_ID', vid = "name",
                  alpha = 0.1, col = COLLAPSE)

9 Session Info

Platform

Packages

ondiskversion loadedversion date source
AnnotationDbi 1.64.1 1.64.1 2024-03-08 Bioconductor 3.18 (R 4.3.3)
apcluster 1.4.11 1.4.11 2023-09-19 CRAN (R 4.3.3)
backports 1.4.1 1.4.1 2021-12-13 CRAN (R 4.3.3)
base64enc 0.1.3 0.1-3 2015-07-28 CRAN (R 4.3.3)
Biobase 2.62.0 2.62.0 2024-03-08 Bioconductor 3.18 (R 4.3.3)
BiocGenerics 0.48.1 0.48.1 2024-03-08 Bioconductor 3.18 (R 4.3.3)
BiocManager 1.30.22 1.30.22 2023-08-08 CRAN (R 4.3.3)
BiocParallel 1.36.0 1.36.0 2024-03-08 Bioconductor 3.18 (R 4.3.3)
BiocStyle 2.30.0 2.30.0 2024-03-08 Bioconductor 3.18 (R 4.3.3)
BioNAR 1.4.4 1.4.4 2024-03-08 Bioconductor 3.18 (R 4.3.3)
Biostrings 2.70.2 2.70.2 2024-03-08 Bioconductor 3.18 (R 4.3.3)
bit 4.0.5 4.0.5 2022-11-15 CRAN (R 4.3.3)
bit64 4.0.5 4.0.5 2020-08-30 CRAN (R 4.3.3)
blob 1.2.4 1.2.4 2023-03-17 CRAN (R 4.3.3)
bookdown 0.38 0.38 2024-03-04 CRAN (R 4.3.3)
bslib 0.6.1 0.6.1 2023-11-28 CRAN (R 4.3.3)
cachem 1.0.8 1.0.8 2023-05-01 CRAN (R 4.3.3)
checkmate 2.3.1 2.3.1 2023-12-04 CRAN (R 4.3.3)
cli 3.6.2 3.6.2 2023-12-11 CRAN (R 4.3.3)
cluster 2.1.6 2.1.6 2023-12-01 CRAN (R 4.3.3)
clusterCons 1.2 1.2 2022-02-22 CRAN (R 4.3.3)
codetools 0.2.19 0.2-19 2023-02-01 CRAN (R 4.3.3)
colorspace 2.1.0 2.1-0 2023-01-23 CRAN (R 4.3.3)
cowplot 1.1.3 1.1.3 2024-01-22 CRAN (R 4.3.3)
crayon 1.5.2 1.5.2 2022-09-29 CRAN (R 4.3.3)
crosstalk 1.2.1 1.2.1 2023-11-23 CRAN (R 4.3.3)
curl 5.2.1 5.2.1 2024-03-01 CRAN (R 4.3.3)
data.table 1.15.2 1.15.2 2024-02-29 CRAN (R 4.3.3)
DBI 1.2.2 1.2.2 2024-02-16 CRAN (R 4.3.3)
devtools 2.4.5 2.4.5 2022-10-11 CRAN (R 4.3.3)
digest 0.6.34 0.6.34 2024-01-11 CRAN (R 4.3.3)
doParallel 1.0.17 1.0.17 2022-02-07 CRAN (R 4.3.3)
dplyr 1.1.4 1.1.4 2023-11-17 CRAN (R 4.3.3)
dynamicTreeCut 1.63.1 1.63-1 2016-03-11 CRAN (R 4.3.3)
ellipsis 0.3.2 0.3.2 2021-04-29 CRAN (R 4.3.3)
evaluate 0.23 0.23 2023-11-01 CRAN (R 4.3.3)
fansi 1.0.6 1.0.6 2023-12-08 CRAN (R 4.3.3)
farver 2.1.1 2.1.1 2022-07-06 CRAN (R 4.3.3)
fastcluster 1.2.6 1.2.6 2024-01-12 CRAN (R 4.3.3)
fastmap 1.1.1 1.1.1 2023-02-24 CRAN (R 4.3.3)
fastmatch 1.1.4 1.1-4 2023-08-18 CRAN (R 4.3.3)
fgsea 1.28.0 1.28.0 2024-03-08 Bioconductor 3.18 (R 4.3.3)
foreach 1.5.2 1.5.2 2022-02-02 CRAN (R 4.3.3)
foreign 0.8.86 0.8-86 2023-11-28 CRAN (R 4.3.3)
Formula 1.2.5 1.2-5 2023-02-24 CRAN (R 4.3.3)
fs 1.6.3 1.6.3 2023-07-20 CRAN (R 4.3.3)
generics 0.1.3 0.1.3 2022-07-05 CRAN (R 4.3.3)
GenomeInfoDb 1.38.7 1.38.7 2024-03-08 Bioconductor 3.18 (R 4.3.3)
GenomeInfoDbData 1.2.11 1.2.11 2024-03-06 Bioconductor
ggplot2 3.5.0 3.5.0 2024-02-23 CRAN (R 4.3.3)
ggrepel 0.9.5 0.9.5 2024-01-10 CRAN (R 4.3.3)
glue 1.7.0 1.7.0 2024-01-09 CRAN (R 4.3.3)
GO.db 3.18.0 3.18.0 2024-03-06 Bioconductor
graph 1.80.0 1.80.0 2024-03-08 Bioconductor 3.18 (R 4.3.3)
gridExtra 2.3 2.3 2017-09-09 CRAN (R 4.3.3)
gtable 0.3.4 0.3.4 2023-08-21 CRAN (R 4.3.3)
highr 0.10 0.10 2022-12-22 CRAN (R 4.3.3)
Hmisc 5.1.1 5.1-1 2023-09-12 CRAN (R 4.3.3)
htmlTable 2.4.2 2.4.2 2023-10-29 CRAN (R 4.3.3)
htmltools 0.5.7 0.5.7 2023-11-03 CRAN (R 4.3.3)
htmlwidgets 1.6.4 1.6.4 2023-12-06 CRAN (R 4.3.3)
httpuv 1.6.14 1.6.14 2024-01-26 CRAN (R 4.3.3)
httr 1.4.7 1.4.7 2023-08-15 CRAN (R 4.3.3)
igraph 2.0.2 2.0.2 2024-02-17 CRAN (R 4.3.3)
impute 1.76.0 1.76.0 2024-03-08 Bioconductor 3.18 (R 4.3.3)
IRanges 2.36.0 2.36.0 2024-03-08 Bioconductor 3.18 (R 4.3.3)
iterators 1.0.14 1.0.14 2022-02-05 CRAN (R 4.3.3)
jquerylib 0.1.4 0.1.4 2021-04-26 CRAN (R 4.3.3)
jsonlite 1.8.8 1.8.8 2023-12-04 CRAN (R 4.3.3)
KEGGREST 1.42.0 1.42.0 2024-03-08 Bioconductor 3.18 (R 4.3.3)
knitr 1.45 1.45 2023-10-30 CRAN (R 4.3.3)
labeling 0.4.3 0.4.3 2023-08-29 CRAN (R 4.3.3)
later 1.3.2 1.3.2 2023-12-06 CRAN (R 4.3.3)
latex2exp 0.9.6 0.9.6 2022-11-28 CRAN (R 4.3.3)
lattice 0.22.5 0.22-5 2023-10-24 CRAN (R 4.3.3)
lazyeval 0.2.2 0.2.2 2019-03-15 CRAN (R 4.3.3)
lifecycle 1.0.4 1.0.4 2023-11-07 CRAN (R 4.3.3)
magick 2.8.3 2.8.3 2024-02-18 CRAN (R 4.3.3)
magrittr 2.0.3 2.0.3 2022-03-30 CRAN (R 4.3.3)
Matrix 1.6.5 1.6-5 2024-01-11 CRAN (R 4.3.3)
matrixStats 1.2.0 1.2.0 2023-12-11 CRAN (R 4.3.3)
memoise 2.0.1 2.0.1 2021-11-26 CRAN (R 4.3.3)
mime 0.12 0.12 2021-09-28 CRAN (R 4.3.3)
miniUI 0.1.1.1 0.1.1.1 2018-05-18 CRAN (R 4.3.3)
minpack.lm 1.2.4 1.2-4 2023-09-11 CRAN (R 4.3.3)
munsell 0.5.0 0.5.0 2018-06-12 CRAN (R 4.3.3)
nnet 7.3.19 7.3-19 2023-05-03 CRAN (R 4.3.3)
org.Hs.eg.db 3.18.0 3.18.0 2024-03-06 Bioconductor
pander 0.6.5 0.6.5 2022-03-18 CRAN (R 4.3.3)
pillar 1.9.0 1.9.0 2023-03-22 CRAN (R 4.3.3)
pkgbuild 1.4.3 1.4.3 2023-12-10 CRAN (R 4.3.3)
pkgconfig 2.0.3 2.0.3 2019-09-22 CRAN (R 4.3.3)
pkgload 1.3.4 1.3.4 2024-01-16 CRAN (R 4.3.3)
plotly 4.10.4 4.10.4 2024-01-13 CRAN (R 4.3.3)
png 0.1.8 0.1-8 2022-11-29 CRAN (R 4.3.3)
poweRlaw 0.80.0 0.80.0 2024-01-25 CRAN (R 4.3.3)
pracma 2.4.4 2.4.4 2023-11-10 CRAN (R 4.3.3)
preprocessCore 1.64.0 1.64.0 2024-03-08 Bioconductor 3.18 (R 4.3.3)
profvis 0.3.8 0.3.8 2023-05-02 CRAN (R 4.3.3)
promises 1.2.1 1.2.1 2023-08-10 CRAN (R 4.3.3)
purrr 1.0.2 1.0.2 2023-08-10 CRAN (R 4.3.3)
R6 2.5.1 2.5.1 2021-08-19 CRAN (R 4.3.3)
randomcoloR 1.1.0.1 1.1.0.1 2019-11-24 CRAN (R 4.3.3)
rbibutils 2.2.16 2.2.16 2023-10-25 CRAN (R 4.3.3)
RColorBrewer 1.1.3 1.1-3 2022-04-03 CRAN (R 4.3.3)
Rcpp 1.0.12 1.0.12 2024-01-09 CRAN (R 4.3.3)
Rdpack 2.6 2.6 2023-11-08 CRAN (R 4.3.3)
remotes 2.4.2.1 2.4.2.1 2023-07-18 CRAN (R 4.3.3)
rlang 1.1.3 1.1.3 2024-01-10 CRAN (R 4.3.3)
rmarkdown 2.26 2.26 2024-03-05 CRAN (R 4.3.3)
rpart 4.1.23 4.1.23 2023-12-05 CRAN (R 4.3.3)
RSpectra 0.16.1 0.16-1 2022-04-24 CRAN (R 4.3.3)
rSpectral 1.0.0.10 1.0.0.10 2023-01-18 CRAN (R 4.3.3)
RSQLite 2.3.5 2.3.5 2024-01-21 CRAN (R 4.3.3)
rstudioapi 0.15.0 0.15.0 2023-07-07 CRAN (R 4.3.3)
Rtsne 0.17 0.17 2023-12-07 CRAN (R 4.3.3)
S4Vectors 0.40.2 0.40.2 2024-03-08 Bioconductor 3.18 (R 4.3.3)
sass 0.4.8 0.4.8 2023-12-06 CRAN (R 4.3.3)
scales 1.3.0 1.3.0 2023-11-28 CRAN (R 4.3.3)
sessioninfo 1.2.2 1.2.2 2021-12-06 CRAN (R 4.3.3)
shiny 1.8.0 1.8.0 2023-11-17 CRAN (R 4.3.3)
stringi 1.8.3 1.8.3 2023-12-11 CRAN (R 4.3.3)
stringr 1.5.1 1.5.1 2023-11-14 CRAN (R 4.3.3)
survival 3.5.8 3.5-8 2024-02-14 CRAN (R 4.3.3)
tibble 3.2.1 3.2.1 2023-03-20 CRAN (R 4.3.3)
tidyr 1.3.1 1.3.1 2024-01-24 CRAN (R 4.3.3)
tidyselect 1.2.0 1.2.0 2022-10-10 CRAN (R 4.3.3)
urlchecker 1.0.1 1.0.1 2021-11-30 CRAN (R 4.3.3)
usethis 2.2.3 2.2.3 2024-02-19 CRAN (R 4.3.3)
utf8 1.2.4 1.2.4 2023-10-22 CRAN (R 4.3.3)
V8 4.4.2 4.4.2 2024-02-15 CRAN (R 4.3.3)
vctrs 0.6.5 0.6.5 2023-12-01 CRAN (R 4.3.3)
viridis 0.6.5 0.6.5 2024-01-29 CRAN (R 4.3.3)
viridisLite 0.4.2 0.4.2 2023-05-02 CRAN (R 4.3.3)
WGCNA 1.72.5 1.72-5 2023-12-07 CRAN (R 4.3.3)
withr 3.0.0 3.0.0 2024-01-16 CRAN (R 4.3.3)
xfun 0.42 0.42 2024-02-08 CRAN (R 4.3.3)
xtable 1.8.4 1.8-4 2019-04-21 CRAN (R 4.3.3)
XVector 0.42.0 0.42.0 2024-03-08 Bioconductor 3.18 (R 4.3.3)
yaml 2.3.8 2.3.8 2023-12-11 CRAN (R 4.3.3)
zlibbioc 1.48.0 1.48.0 2024-03-08 Bioconductor 3.18 (R 4.3.3)