License: arXiv.org perpetual non-exclusive license
arXiv:2403.05654v1 [math.ST] 08 Mar 2024
\renewtheoremstyle

plain

\jyear

? \jvol? \jnum? \accessdate

Dynamic clustering for heterophilic stochastic block models with time-varying node memberships

K. Z. LIN [email protected] Department of Biostatistics, University of Washington    J. LEI [email protected] Department of Statistics & Data Science, Carnegie Mellon University
Abstract

We consider a time-ordered sequence of networks stemming from stochastic block models where nodes gradually change memberships over time and no network at any single time point contains sufficient signal strength to recover its community structure. To estimate the time-varying community structure, we develop KD-SoS (kernel debiased sum-of-square), a method performing spectral clustering after a debiased sum-of-squared aggregation of adjacency matrices. Our theory demonstrates via a novel bias-variance decomposition that KD-SoS achieves consistent community detection of each network even when heterophilic networks do not require smoothness in the time-varying dynamics of between-community connectivities. We also prove the identifiability of aligning community structures across time based on how rapidly nodes change communities, and develop a data-adaptive bandwidth tuning procedure for KD-SoS. We demonstrate the utility and advantages of KD-SoS through simulations and a novel analysis of the time-varying dynamics in gene coordination in the human develo** brain system.

keywords:
Gene co-expression network, human brain development, network analysis, non-parametric analysis, single-cell RNA-seq, time-varying model
journal: Biometrika

\arabicsection Introduction

Longitudinal analyses of a network reveal insights into how communities of nodes are lost or created over time. Due to the complexity of most networks, statistical methods are necessary to uncover these broad dynamics. Simply put, suppose we observe a time-ordered sequence of networks among the same n𝑛nitalic_n nodes represented as symmetric binary matrices A(0),,A(1){0,1}n×nsuperscript𝐴0superscript𝐴1superscript01𝑛𝑛A^{(0)},\ldots,A^{(1)}\in\{0,1\}^{n\times n}italic_A start_POSTSUPERSCRIPT ( 0 ) end_POSTSUPERSCRIPT , … , italic_A start_POSTSUPERSCRIPT ( 1 ) end_POSTSUPERSCRIPT ∈ { 0 , 1 } start_POSTSUPERSCRIPT italic_n × italic_n end_POSTSUPERSCRIPT, where for time t[0,1]𝑡01t\in[0,1]italic_t ∈ [ 0 , 1 ], the (i,j)𝑖𝑗(i,j)( italic_i , italic_j )-entry of A(t)superscript𝐴𝑡A^{(t)}italic_A start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT denotes the presence or absence of interaction between two nodes at time t𝑡titalic_t. Due to the non-Euclidean nature of the data, it is often difficult to assess if the larger-scale community structures changed over time and, if so, which specific nodes were changing communities at what rate. Sarkar & Moore (2006) developed one of the first methods to investigate these time-varying dynamics. However, research on the statistical properties of such estimators is recent by comparison (Han et al., 2015). See Kim et al. (2018); Pensky & Zhang (2019) for a comprehensive overview. Our goal in this paper is to provide a theoretically justifiable new method that is computationally efficient and can handle a wide range of network dynamics.

In this work, we focus on understanding the dynamics of gene coordination over human brain development, but our methods are applicable more broadly to investigate any time-ordered sequence of networks. Consider the single-cell RNA-seq (scRNA-seq) dataset initially published in Trevino et al. (2021), where the authors delineated a specific set of 18,160 cells representing how cycling progenitors (orange) develop into numerous types of maturing glutamatergics (shades of teal). The authors annotated these cells and discovered a set of 993 genes associated with their development. This data can be visualized through a UMAP (McInnes et al., 2018), a non-linear dimension-reduction method (Figure \arabicfigureA). Using typical tools in the single-cell analysis toolbox such as Slingshot (Street et al., 2018), we can order the cells in this lineage from the youngest to oldest cells (Figure \arabicfigureB) and visualize how the gene expression evolves across this lineage (Figure \arabicfigureC). However, while this simple analysis shows apparent dynamics of the mean gene expression across pseudotime, the evolution of the gene coordination patterns is unknown. Do the genes tightly coordinated at the beginning of development remain tightly coordinated at the end of development, and are there tightly coordinated genes that are not highly expressed?

Refer to caption
Figure \arabicfigure: A) UMAP of the cells among the human develo** brain, highlighting the 18,160 cells relevant to our analysis. These denotes cell types such as cycling progenitors (orange) and maturing glutamatergics (shades of teal). B) The 18,160 cells colored based on their estimated pseudotime using Slingshot (Street et al., 2018), colored from youngest (bright yellow) to oldest (dark purple). C) Heatmap ordering the cells based on their estimated pseudotime, and ordering the 993 relevant genes for this development. The gene expression for each cell is colored based on their expression (high as yellow, low as dark blue).

As reviewed in Kim et al. (2018), many statistical models exist for time-varying networks. This work focuses on time-varying stochastic block models (SBMs). SBMs (Holland et al., 1983) are a class of prototypical networks that reveal insightful theory while being flexible enough to model many networks in practice. Broadly speaking, an SBM represents each node as part of K𝐾Kitalic_K (unobserved) communities, and the presence of an edge between two nodes is determined solely by the nodes’ community label. Previous work has proven that there is a fundamental limit on how sparse the SBM can be before recovering the communities is impossible (Abbe, 2017). However, this fundamental limit could become even sparser when there is a collection of SBMs. This has led to many different lines of work. For example, one line of work studies the fixed community structure, where T𝑇Titalic_T SBMs are observed with all the same community structure (Lei et al., 2020; Bhattacharyya & Chatterjee, 2020; Paul & Chen, 2020; Arroyo et al., 2021; Lei & Lin, 2022). A variant is that no temporal structure is imposed across the T𝑇Titalic_T networks, but instead, each network slightly deviates from a common community structure at random (Chen et al., 2020). Another line of work is when T𝑇Titalic_T time-ordered SBMs are observed, but there is a changepoint – all the networks before or all the networks after the changepoint share the same community structure (Liu et al., 2018; Wang et al., 2021).

Despite the abundance of aforementioned SBM models equipped with rigorous theory, they only partially apply to our intended analysis of the human develo** brain. To provide the reader with a scope of the analysis, we plot the correlation network among the 993 genes for three different time points in Figure \arabicfigure. These networks were constructed from 12 non-overlap** partitioning of cells across the estimated time, and we observe potentially gradual changes in community structure over time. See the Appendix for more details on the preprocessing. Hence, we turn towards time-varying SBM models, where the community structure changes slowly over time. To date, Pensky & Zhang (2019) and Keriven & Vaiter (2022) are among the only works that study this setting. This difficulty is induced by the simple observation that changes in community structure are discrete, which prevents typical non-parametric techniques from being easily applied. However, as discussed later, we take a different theoretical approach to analyze this problem and prove consistent estimation of each network’s community under broader assumptions. We briefly note that beyond time-varying SBMs, there are works on time-varying latent-position graphs (Gallagher et al., 2021; Athreya et al., 2022). Latent-position graphs are more general than SBMs, as they do not impose a community structure. In this work, we focus on SBMs as they are more applicable to understanding the gene coordination dynamics in the develo** brain.

Refer to caption
Figure \arabicfigure: Three of twelve networks, for t=1/12𝑡112t=1/12italic_t = 1 / 12 (i.e., gene network among the youngest cells), t=7/12𝑡712t=7/12italic_t = 7 / 12 and t=12/12𝑡1212t=12/12italic_t = 12 / 12 (i.e., gene network among the oldest cells). These are constructed based on thresholding the correlation matrix among the 993 genes. The visual position of each gene is fixed for each network, but the edges among the gene varies.

The main contribution of this paper is a novel and computationally efficient method equipped with theoretical guarantees regarding community estimation in temporal SBMs with a time-varying community structure. Our method is inspired by Lei & Lin (2022), where a debiased sum-of-squared estimator was proven to estimate communities for fixed-community multi-layer networks consistently, allowing for both homophilic and heterophilic networks. We adapt this to the time-varying setting by introducing a kernel smoother and prove through a novel bias-variance decomposition that it can consistently estimate the time-varying communities, holding all other assumptions the same. In particular, while the nodes are gradually changing communities, we impose almost no conditions on the connectivity patterns except the positivity of the locally averaged squared connectivity matrix. We also formalize the information-theoretic relation between the number of networks and the rate nodes change communities as an identifiability condition.

Our second contribution is a tuning procedure for an appropriate kernel bandwidth that also does not impose restrictions on how the community relations change across networks. Leave-one-out tuning procedures designed in other matrix applications (Yang & Peng, 2020) where network t𝑡titalic_t is predicted using other temporally surrounding networks are inappropriate since these procedures require community relations to change smoothly over time. This also precludes Lepskii-based procedures (Pensky & Zhang, 2019). In contrast, our procedure is designed based on the cosine distance between eigenspaces – for network t𝑡titalic_t, the cosine distance is computed between the eigenspaces of kernel-weighted networks for a time less than t𝑡titalic_t and of kernel-weighted networks for a time greater than t𝑡titalic_t respectively. The bandwidth that minimizes this distance averaged over all t𝑡titalic_t is deemed the most appropriate. We show through simulation studies and a thorough investigation of the scRNA-seq data that this procedure selects a desirable bandwidth.

\arabicsection Dynamic stochastic block model

Let n𝑛nitalic_n denote the number of nodes, and m(0){1,,K}nsuperscript𝑚0superscript1𝐾𝑛m^{(0)}\in\{1,\ldots,K\}^{n}italic_m start_POSTSUPERSCRIPT ( 0 ) end_POSTSUPERSCRIPT ∈ { 1 , … , italic_K } start_POSTSUPERSCRIPT italic_n end_POSTSUPERSCRIPT denote the initial membership vector, where K𝐾Kitalic_K is a fixed number of communities. That is, mi(0)=ksubscriptsuperscript𝑚0𝑖𝑘m^{(0)}_{i}=kitalic_m start_POSTSUPERSCRIPT ( 0 ) end_POSTSUPERSCRIPT start_POSTSUBSCRIPT italic_i end_POSTSUBSCRIPT = italic_k for k{1,,K}𝑘1𝐾k\in\{1,\ldots,K\}italic_k ∈ { 1 , … , italic_K } if node i𝑖iitalic_i starts in community k𝑘kitalic_k. We posit that each of the n𝑛nitalic_n nodes changes communities according to a Poisson(γ)Poisson𝛾\operatorname{{Poisson}}(\gamma)roman_Poisson ( italic_γ ) process with γ>0𝛾0\gamma>0italic_γ > 0, independent of all other nodes. This means node i{1,,n}𝑖1𝑛i\in\{1,\ldots,n\}italic_i ∈ { 1 , … , italic_n } changes communities at random times 0<xi,1<xi,2<<10subscript𝑥𝑖1subscript𝑥𝑖210<x_{i,1}<x_{i,2}<\ldots<10 < italic_x start_POSTSUBSCRIPT italic_i , 1 end_POSTSUBSCRIPT < italic_x start_POSTSUBSCRIPT italic_i , 2 end_POSTSUBSCRIPT < … < 1 where the expected difference between consecutive times is 1/γ1𝛾1/\gamma1 / italic_γ, and the node changes to one of the K1𝐾1K-1italic_K - 1 other communities with arbitrary probability. This process generates membership vectors m(t)superscript𝑚𝑡m^{(t)}italic_m start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT for t[0,1]𝑡01t\in[0,1]italic_t ∈ [ 0 , 1 ].

Although each node can potentially change communities multiple times throughout t[0,1]𝑡01t\in[0,1]italic_t ∈ [ 0 , 1 ], we assume that only T𝑇Titalic_T graphs at fixed time points are observed for

𝒯={1T,2T,, 1}.𝒯1𝑇2𝑇1\mathcal{T}=\Big{\{}\frac{1}{T},\;\frac{2}{T},\;\ldots,\;1\Big{\}}.caligraphic_T = { divide start_ARG 1 end_ARG start_ARG italic_T end_ARG , divide start_ARG 2 end_ARG start_ARG italic_T end_ARG , … , 1 } .

The generative model for a specific graph A(t){0,1}n×nsuperscript𝐴𝑡superscript01𝑛𝑛A^{(t)}\in\{0,1\}^{n\times n}italic_A start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ∈ { 0 , 1 } start_POSTSUPERSCRIPT italic_n × italic_n end_POSTSUPERSCRIPT for a time t𝒯𝑡𝒯t\in\mathcal{T}italic_t ∈ caligraphic_T is as follows. Let B(t)[0,1]K×Ksuperscript𝐵𝑡superscript01𝐾𝐾B^{(t)}\in[0,1]^{K\times K}italic_B start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ∈ [ 0 , 1 ] start_POSTSUPERSCRIPT italic_K × italic_K end_POSTSUPERSCRIPT be a symmetric matrix that denotes the connectivity matrix among the K𝐾Kitalic_K communities for a fixed positive integer K𝐾Kitalic_K, and let m(t)superscript𝑚𝑡m^{(t)}italic_m start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT be the random membership vector based on the above Poisson(γ)Poisson𝛾\operatorname{{Poisson}}(\gamma)roman_Poisson ( italic_γ ) process. Each membership vector m(t)superscript𝑚𝑡m^{(t)}italic_m start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT can be encoded as one-hot membership matrix M(t){0,1}n×Ksuperscript𝑀𝑡superscript01𝑛𝐾M^{(t)}\in\{0,1\}^{n\times K}italic_M start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ∈ { 0 , 1 } start_POSTSUPERSCRIPT italic_n × italic_K end_POSTSUPERSCRIPT where Mik(t)=1superscriptsubscript𝑀𝑖𝑘𝑡1M_{ik}^{(t)}=1italic_M start_POSTSUBSCRIPT italic_i italic_k end_POSTSUBSCRIPT start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT = 1 if and only if node i𝑖iitalic_i is in community k𝑘kitalic_k, and 0 otherwise. Then, the probability matrix Q(t)[0,1]n×nsuperscript𝑄𝑡superscript01𝑛𝑛Q^{(t)}\in[0,1]^{n\times n}italic_Q start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ∈ [ 0 , 1 ] start_POSTSUPERSCRIPT italic_n × italic_n end_POSTSUPERSCRIPT is defined as

Q(t)=ρnM(t)B(t)(M(t)),superscript𝑄𝑡subscript𝜌𝑛superscript𝑀𝑡superscript𝐵𝑡superscriptsuperscript𝑀𝑡topQ^{(t)}=\rho_{n}\cdot M^{(t)}B^{(t)}\big{(}M^{(t)}\big{)}^{\top},italic_Q start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT = italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT ⋅ italic_M start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT italic_B start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ( italic_M start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT ⊤ end_POSTSUPERSCRIPT , (\arabicequation)

for a network density parameter ρn(0,1)subscript𝜌𝑛01\rho_{n}\in(0,1)italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT ∈ ( 0 , 1 ), and P(t)=Q(t)diag(Q(t))superscript𝑃𝑡superscript𝑄𝑡diagsuperscript𝑄𝑡P^{(t)}=Q^{(t)}-\operatorname{{diag}}(Q^{(t)})italic_P start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT = italic_Q start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT - roman_diag ( italic_Q start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ). The observed graph A(t)superscript𝐴𝑡A^{(t)}italic_A start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT for time t𝒯𝑡𝒯t\in\mathcal{T}italic_t ∈ caligraphic_T is then sampled according to

Aij(t)={Bernoulli(Pij(t)),if i>j,0if i=j,Aji(t)otherwise.subscriptsuperscript𝐴𝑡𝑖𝑗casesBernoullisuperscriptsubscript𝑃𝑖𝑗𝑡if 𝑖𝑗0if 𝑖𝑗subscriptsuperscript𝐴𝑡𝑗𝑖otherwiseA^{(t)}_{ij}=\begin{cases}\operatorname{{Bernoulli}}\big{(}P_{ij}^{(t)}\big{)}% ,&\quad\text{if }i>j,\\ 0&\quad\text{if }i=j,\\ A^{(t)}_{ji}&\quad\text{otherwise}.\end{cases}italic_A start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT start_POSTSUBSCRIPT italic_i italic_j end_POSTSUBSCRIPT = { start_ROW start_CELL roman_Bernoulli ( italic_P start_POSTSUBSCRIPT italic_i italic_j end_POSTSUBSCRIPT start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ) , end_CELL start_CELL if italic_i > italic_j , end_CELL end_ROW start_ROW start_CELL 0 end_CELL start_CELL if italic_i = italic_j , end_CELL end_ROW start_ROW start_CELL italic_A start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT start_POSTSUBSCRIPT italic_j italic_i end_POSTSUBSCRIPT end_CELL start_CELL otherwise . end_CELL end_ROW (\arabicequation)

This implies the following relation:

𝔼[A(t)]=P(t)=Q(t)diag(Q(t)).𝔼delimited-[]superscript𝐴𝑡superscript𝑃𝑡superscript𝑄𝑡diagsuperscript𝑄𝑡\mathbb{E}\big{[}A^{(t)}\big{]}=P^{(t)}=Q^{(t)}-\operatorname{{diag}}\big{(}Q^% {(t)}\big{)}.blackboard_E [ italic_A start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ] = italic_P start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT = italic_Q start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT - roman_diag ( italic_Q start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ) .

For two membership matrices M𝑀Mitalic_M, Msuperscript𝑀M^{\prime}italic_M start_POSTSUPERSCRIPT ′ end_POSTSUPERSCRIPT, define their confusion matrix C(M,M)𝐶𝑀superscript𝑀C(M,M^{\prime})italic_C ( italic_M , italic_M start_POSTSUPERSCRIPT ′ end_POSTSUPERSCRIPT ) as

Ck(M,M)=|{i{1,,n}:Mik=1 and Mi=1}|.subscript𝐶𝑘𝑀superscript𝑀conditional-set𝑖1𝑛subscript𝑀𝑖𝑘1 and subscriptsuperscript𝑀𝑖1C_{k\ell}(M,M^{\prime})=\Big{|}\big{\{}i\in\{1,\ldots,n\}:M_{ik}=1\text{ and }% M^{\prime}_{i\ell}=1\big{\}}\Big{|}.italic_C start_POSTSUBSCRIPT italic_k roman_ℓ end_POSTSUBSCRIPT ( italic_M , italic_M start_POSTSUPERSCRIPT ′ end_POSTSUPERSCRIPT ) = | { italic_i ∈ { 1 , … , italic_n } : italic_M start_POSTSUBSCRIPT italic_i italic_k end_POSTSUBSCRIPT = 1 and italic_M start_POSTSUPERSCRIPT ′ end_POSTSUPERSCRIPT start_POSTSUBSCRIPT italic_i roman_ℓ end_POSTSUBSCRIPT = 1 } | . (\arabicequation)

Since the outputs of most clustering algorithms do not distinguish label permutations, to match the label permutation between M𝑀Mitalic_M and Msuperscript𝑀M^{\prime}italic_M start_POSTSUPERSCRIPT ′ end_POSTSUPERSCRIPT, we solve the following assignment problem,

R(M,M)=argmaxRKdiag(C(M,M)R)1,𝑅𝑀superscript𝑀subscript𝑅subscript𝐾subscriptnormdiag𝐶𝑀superscript𝑀𝑅1R(M,M^{\prime})=\arg\max_{R\in\mathbb{Q}_{K}}\big{\|}\operatorname{{diag}}(C(M% ,M^{\prime})R)\big{\|}_{1},italic_R ( italic_M , italic_M start_POSTSUPERSCRIPT ′ end_POSTSUPERSCRIPT ) = roman_arg roman_max start_POSTSUBSCRIPT italic_R ∈ blackboard_Q start_POSTSUBSCRIPT italic_K end_POSTSUBSCRIPT end_POSTSUBSCRIPT ∥ roman_diag ( italic_C ( italic_M , italic_M start_POSTSUPERSCRIPT ′ end_POSTSUPERSCRIPT ) italic_R ) ∥ start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT , (\arabicequation)

where Ksubscript𝐾\mathbb{Q}_{K}blackboard_Q start_POSTSUBSCRIPT italic_K end_POSTSUBSCRIPT is the set of K×K𝐾𝐾K\times Kitalic_K × italic_K permutation matrices. Equipped with C(M,M)𝐶𝑀superscript𝑀C(M,M^{\prime})italic_C ( italic_M , italic_M start_POSTSUPERSCRIPT ′ end_POSTSUPERSCRIPT ) and R(M,M)𝑅𝑀superscript𝑀R(M,M^{\prime})italic_R ( italic_M , italic_M start_POSTSUPERSCRIPT ′ end_POSTSUPERSCRIPT ), we define L(M,M)𝐿𝑀superscript𝑀L(M,M^{\prime})italic_L ( italic_M , italic_M start_POSTSUPERSCRIPT ′ end_POSTSUPERSCRIPT ) to be the relative Hamming distance between the two membership matrices M𝑀Mitalic_M and Msuperscript𝑀M^{\prime}italic_M start_POSTSUPERSCRIPT ′ end_POSTSUPERSCRIPT,

L(M,M)=11ndiag(C(M,M)R(M,M)1,L(M,M^{\prime})=1-\frac{1}{n}\big{\|}\operatorname{{diag}}(C(M,M^{\prime})R(M,% M^{\prime})\|_{1}\,,italic_L ( italic_M , italic_M start_POSTSUPERSCRIPT ′ end_POSTSUPERSCRIPT ) = 1 - divide start_ARG 1 end_ARG start_ARG italic_n end_ARG ∥ roman_diag ( italic_C ( italic_M , italic_M start_POSTSUPERSCRIPT ′ end_POSTSUPERSCRIPT ) italic_R ( italic_M , italic_M start_POSTSUPERSCRIPT ′ end_POSTSUPERSCRIPT ) ∥ start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT , (\arabicequation)

or, in other words, the total proportion of mis-clustered nodes after optimal alignment. Furthermore, we define a square matrix XK×K𝑋superscript𝐾𝐾X\in\mathbb{R}^{K\times K}italic_X ∈ blackboard_R start_POSTSUPERSCRIPT italic_K × italic_K end_POSTSUPERSCRIPT to be diagonally dominant if Xkk:k|Xk|subscript𝑋𝑘𝑘subscript:𝑘subscript𝑋𝑘X_{kk}\geq\sum_{\ell:\ell\neq k}|X_{k\ell}|italic_X start_POSTSUBSCRIPT italic_k italic_k end_POSTSUBSCRIPT ≥ ∑ start_POSTSUBSCRIPT roman_ℓ : roman_ℓ ≠ italic_k end_POSTSUBSCRIPT | italic_X start_POSTSUBSCRIPT italic_k roman_ℓ end_POSTSUBSCRIPT | for each k{1,,K}𝑘1𝐾k\in\{1,\ldots,K\}italic_k ∈ { 1 , … , italic_K }. If C(M,M)R(M,M)𝐶𝑀superscript𝑀𝑅𝑀superscript𝑀C(M,M^{\prime})R(M,M^{\prime})italic_C ( italic_M , italic_M start_POSTSUPERSCRIPT ′ end_POSTSUPERSCRIPT ) italic_R ( italic_M , italic_M start_POSTSUPERSCRIPT ′ end_POSTSUPERSCRIPT ) and C(M,M)R(M,M)𝐶superscript𝑀𝑀𝑅superscript𝑀𝑀C(M^{\prime},M)R(M^{\prime},M)italic_C ( italic_M start_POSTSUPERSCRIPT ′ end_POSTSUPERSCRIPT , italic_M ) italic_R ( italic_M start_POSTSUPERSCRIPT ′ end_POSTSUPERSCRIPT , italic_M ) are both diagonally dominant, we say that the two membership matrices M,M𝑀superscript𝑀M,M^{\prime}italic_M , italic_M start_POSTSUPERSCRIPT ′ end_POSTSUPERSCRIPT as alignable. This means there is an unambiguous map** of the K𝐾Kitalic_K communities in M𝑀Mitalic_M to those in Msuperscript𝑀M^{\prime}italic_M start_POSTSUPERSCRIPT ′ end_POSTSUPERSCRIPT.

Our theoretical goal is to show the interplay between the number of nodes n𝑛nitalic_n, the number of observed networks T𝑇Titalic_T, community switching rate γ𝛾\gammaitalic_γ, and the network-sparsity parameter ρnsubscript𝜌𝑛\rho_{n}italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT needed to estimate the T𝑇Titalic_T membership matrices across time consistently. The existing theory of single-layer SBMs has already shown that if ρnlog(n)greater-than-or-equivalent-tosubscript𝜌𝑛𝑛\rho_{n}\gtrsim\log(n)italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT ≳ roman_log ( italic_n ) for a single network, spectral clustering can asymptotically recover the community structure. At the same time, no method can achieve exact recovery if ρnlog(n)less-than-or-similar-tosubscript𝜌𝑛𝑛\rho_{n}\lesssim\log(n)italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT ≲ roman_log ( italic_n ) (Bickel & Chen, 2009; Lei & Rinaldo, 2015; Abbe, 2017). We are interested primarily in the latter setting, ho** the temporal structure can boost the signal for estimation. Some previous methods and theoretical analyses for this setting require strict assumptions on connectivity matrices {B(t)}superscript𝐵𝑡\{B^{(t)}\}{ italic_B start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT } (Pensky & Zhang, 2019; Keriven & Vaiter, 2022) – these matrices are required to vary across time smoothly and have strictly positive eigenvalues, i.e., cannot display patterns of heterophily where edges between communities are more frequent than edges within communities. We seek to develop a method that does not require these assumptions, extending the line of work in Lei et al. (2020); Lei & Lin (2022) to temporal SBMs with varying communities.

\arabicsection Debiasing and kernel smoothing

\arabicsection.\arabicsubsection Estimator

Our estimator, the kernel debiased sum-of-squared (KD-SoS) spectral clustering, is motivated by Lei & Lin (2022), where we adopt using the de-biased sum of squared adjacency matrices to handle heterophilic networks. We describe our method using the box kernel for simplicity, but the method and theory can be extended to any kernels that are bounded, continuous, symmetric, non-negative and integrate to 1. The estimation procedure consists of two phases: individual time point smoothing and temporal aligning.

Provided a bandwidth r[0,1]𝑟01r\in[0,1]italic_r ∈ [ 0 , 1 ] and a number of communities K𝐾Kitalic_K, our estimator applies the following procedure for any t𝒯𝑡𝒯t\in\mathcal{T}italic_t ∈ caligraphic_T. First, compute the de-biased sum of squared adjacency matrices, where the summation is over all networks within a bandwidth r𝑟ritalic_r,

Z(t;r)=s𝒮(t;r)[(A(s))2D(s)],where𝒮(t;r)=𝒯[tr,t+r],formulae-sequencesuperscript𝑍𝑡𝑟subscript𝑠𝒮𝑡𝑟delimited-[]superscriptsuperscript𝐴𝑠2superscript𝐷𝑠where𝒮𝑡𝑟𝒯𝑡𝑟𝑡𝑟Z^{(t;r)}=\sum_{s\in\mathcal{S}(t;r)}\left[(A^{(s)})^{2}-D^{(s)}\right],\quad% \text{where}\quad\mathcal{S}(t;r)=\mathcal{T}\cap[t-r,t+r],italic_Z start_POSTSUPERSCRIPT ( italic_t ; italic_r ) end_POSTSUPERSCRIPT = ∑ start_POSTSUBSCRIPT italic_s ∈ caligraphic_S ( italic_t ; italic_r ) end_POSTSUBSCRIPT [ ( italic_A start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT - italic_D start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT ] , where caligraphic_S ( italic_t ; italic_r ) = caligraphic_T ∩ [ italic_t - italic_r , italic_t + italic_r ] , (\arabicequation)

and D(t)n×nsuperscript𝐷𝑡superscript𝑛𝑛D^{(t)}\in\mathbb{R}^{n\times n}italic_D start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ∈ blackboard_R start_POSTSUPERSCRIPT italic_n × italic_n end_POSTSUPERSCRIPT is the (random) diagonal matrix encoding the degrees of the n𝑛nitalic_n nodes, i.e.,

[D(t)]ii=j=1nAij(t),for all i{1,,n}.formulae-sequencesubscriptdelimited-[]superscript𝐷𝑡𝑖𝑖superscriptsubscript𝑗1𝑛subscriptsuperscript𝐴𝑡𝑖𝑗for all 𝑖1𝑛\big{[}D^{(t)}\big{]}_{ii}=\sum_{j=1}^{n}A^{(t)}_{ij},\quad\text{for all }i\in% \{1,\ldots,n\}.[ italic_D start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ] start_POSTSUBSCRIPT italic_i italic_i end_POSTSUBSCRIPT = ∑ start_POSTSUBSCRIPT italic_j = 1 end_POSTSUBSCRIPT start_POSTSUPERSCRIPT italic_n end_POSTSUPERSCRIPT italic_A start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT start_POSTSUBSCRIPT italic_i italic_j end_POSTSUBSCRIPT , for all italic_i ∈ { 1 , … , italic_n } .

Second, compute eigendecomposition of Z^(t;r)superscript^𝑍𝑡𝑟\widehat{Z}^{(t;r)}over^ start_ARG italic_Z end_ARG start_POSTSUPERSCRIPT ( italic_t ; italic_r ) end_POSTSUPERSCRIPT,

Z^(t;r)=U^(t;r)Λ^(t;r)(U^(t;r)),superscript^𝑍𝑡𝑟superscript^𝑈𝑡𝑟superscript^Λ𝑡𝑟superscriptsuperscript^𝑈𝑡𝑟top\widehat{Z}^{(t;r)}=\widehat{U}^{(t;r)}\widehat{\Lambda}^{(t;r)}(\widehat{U}^{% (t;r)})^{\top},over^ start_ARG italic_Z end_ARG start_POSTSUPERSCRIPT ( italic_t ; italic_r ) end_POSTSUPERSCRIPT = over^ start_ARG italic_U end_ARG start_POSTSUPERSCRIPT ( italic_t ; italic_r ) end_POSTSUPERSCRIPT over^ start_ARG roman_Λ end_ARG start_POSTSUPERSCRIPT ( italic_t ; italic_r ) end_POSTSUPERSCRIPT ( over^ start_ARG italic_U end_ARG start_POSTSUPERSCRIPT ( italic_t ; italic_r ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT ⊤ end_POSTSUPERSCRIPT , (\arabicequation)

where the diagonal entries of Λ^(t;r)superscript^Λ𝑡𝑟\widehat{\Lambda}^{(t;r)}over^ start_ARG roman_Λ end_ARG start_POSTSUPERSCRIPT ( italic_t ; italic_r ) end_POSTSUPERSCRIPT are in descending order, and lastly, apply K-means clustering row-wise on the first K𝐾Kitalic_K columns of U^(t;r)superscript^𝑈𝑡𝑟\widehat{U}^{(t;r)}over^ start_ARG italic_U end_ARG start_POSTSUPERSCRIPT ( italic_t ; italic_r ) end_POSTSUPERSCRIPT. This yields the estimated memberships m~(t){1,,K}nsuperscript~𝑚𝑡superscript1𝐾𝑛\widetilde{m}^{(t)}\in\{1,\ldots,K\}^{n}over~ start_ARG italic_m end_ARG start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ∈ { 1 , … , italic_K } start_POSTSUPERSCRIPT italic_n end_POSTSUPERSCRIPT. This debiased sum-of-squared estimator is proven in Lei & Lin (2022) to consistently estimate communities under the fixed-community setting, where the squaring of adjacency matrices enable the population connectivity matrices {B(t)}superscript𝐵𝑡\{B^{(t)}\}{ italic_B start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT } to be semidefinite, and the debiasing corrects for the additive noise incurred by this squaring. This completes the estimation for each individual time point.

After estimating the communities for all T𝑇Titalic_T time points, we align the estimated communities across time. Specifically, initialize M^(1/T)superscript^𝑀1𝑇\widehat{M}^{(1/T)}over^ start_ARG italic_M end_ARG start_POSTSUPERSCRIPT ( 1 / italic_T ) end_POSTSUPERSCRIPT as the one-hot membership matrix of m~(1/T)superscript~𝑚1𝑇\widetilde{m}^{(1/T)}over~ start_ARG italic_m end_ARG start_POSTSUPERSCRIPT ( 1 / italic_T ) end_POSTSUPERSCRIPT. Let δ=1/T𝛿1𝑇\delta=1/Titalic_δ = 1 / italic_T. Then, suppose the aligned membership M^(t)superscript^𝑀𝑡\widehat{M}^{(t)}over^ start_ARG italic_M end_ARG start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT has been obtained, and we want to align the membership for M~(t+δ)superscript~𝑀𝑡𝛿\widetilde{M}^{(t+\delta)}over~ start_ARG italic_M end_ARG start_POSTSUPERSCRIPT ( italic_t + italic_δ ) end_POSTSUPERSCRIPT, the one-hot membership matrix for m~(t+δ)superscript~𝑚𝑡𝛿\widetilde{m}^{(t+\delta)}over~ start_ARG italic_m end_ARG start_POSTSUPERSCRIPT ( italic_t + italic_δ ) end_POSTSUPERSCRIPT. Define the confusion matrix

C~(t,t+δ)=C(M^(t),M~(t+δ)),superscript~𝐶𝑡𝑡𝛿𝐶superscript^𝑀𝑡superscript~𝑀𝑡𝛿\widetilde{C}^{(t,t+\delta)}=C(\widehat{M}^{(t)},\widetilde{M}^{(t+\delta)})\,,over~ start_ARG italic_C end_ARG start_POSTSUPERSCRIPT ( italic_t , italic_t + italic_δ ) end_POSTSUPERSCRIPT = italic_C ( over^ start_ARG italic_M end_ARG start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT , over~ start_ARG italic_M end_ARG start_POSTSUPERSCRIPT ( italic_t + italic_δ ) end_POSTSUPERSCRIPT ) , (\arabicequation)

according to the definition in (\arabicequation), and solve the following assignment problem,

R^(t,t+δ)=R(M^(t),M~(t+δ)),superscript^𝑅𝑡𝑡𝛿𝑅superscript^𝑀𝑡superscript~𝑀𝑡𝛿\widehat{R}^{(t,t+\delta)}=R(\widehat{M}^{(t)},\widetilde{M}^{(t+\delta)})\,,over^ start_ARG italic_R end_ARG start_POSTSUPERSCRIPT ( italic_t , italic_t + italic_δ ) end_POSTSUPERSCRIPT = italic_R ( over^ start_ARG italic_M end_ARG start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT , over~ start_ARG italic_M end_ARG start_POSTSUPERSCRIPT ( italic_t + italic_δ ) end_POSTSUPERSCRIPT ) , (\arabicequation)

according to (\arabicequation). This can be formulated as an Hungarian assignment problem, which can be solved via linear programming. Then, we align M~(t+δ)superscript~𝑀𝑡𝛿\widetilde{M}^{(t+\delta)}over~ start_ARG italic_M end_ARG start_POSTSUPERSCRIPT ( italic_t + italic_δ ) end_POSTSUPERSCRIPT with M^(t)superscript^𝑀𝑡\widehat{M}^{(t)}over^ start_ARG italic_M end_ARG start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT by using

M^(t+δ)=M~(t+δ)R^(t,t+δ).superscript^𝑀𝑡𝛿superscript~𝑀𝑡𝛿superscript^𝑅𝑡𝑡𝛿\widehat{M}^{(t+\delta)}=\widetilde{M}^{(t+\delta)}\widehat{R}^{(t,t+\delta)}\,.over^ start_ARG italic_M end_ARG start_POSTSUPERSCRIPT ( italic_t + italic_δ ) end_POSTSUPERSCRIPT = over~ start_ARG italic_M end_ARG start_POSTSUPERSCRIPT ( italic_t + italic_δ ) end_POSTSUPERSCRIPT over^ start_ARG italic_R end_ARG start_POSTSUPERSCRIPT ( italic_t , italic_t + italic_δ ) end_POSTSUPERSCRIPT .

Let the estimated memberships for time t𝑡titalic_t to be m^(t)superscript^𝑚𝑡\widehat{m}^{(t)}over^ start_ARG italic_m end_ARG start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT where m^(t)=ksuperscript^𝑚𝑡𝑘\widehat{m}^{(t)}=kover^ start_ARG italic_m end_ARG start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT = italic_k if and only if m~(t)=superscript~𝑚𝑡\widetilde{m}^{(t)}=\ellover~ start_ARG italic_m end_ARG start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT = roman_ℓ and R^k(t,t+δ)=1subscriptsuperscript^𝑅𝑡𝑡𝛿𝑘1\widehat{R}^{(t,t+\delta)}_{\ell k}=1over^ start_ARG italic_R end_ARG start_POSTSUPERSCRIPT ( italic_t , italic_t + italic_δ ) end_POSTSUPERSCRIPT start_POSTSUBSCRIPT roman_ℓ italic_k end_POSTSUBSCRIPT = 1. Finally, we return the final estimated memberships m^(t)superscript^𝑚𝑡\widehat{m}^{(t)}over^ start_ARG italic_m end_ARG start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT for t𝒯𝑡𝒯t\in\mathcal{T}italic_t ∈ caligraphic_T.

Optionally, we can compute if C~(t,t+δ)R^(t,t+δ)superscript~𝐶𝑡𝑡𝛿superscript^𝑅𝑡𝑡𝛿\widetilde{C}^{(t,t+\delta)}\widehat{R}^{(t,t+\delta)}over~ start_ARG italic_C end_ARG start_POSTSUPERSCRIPT ( italic_t , italic_t + italic_δ ) end_POSTSUPERSCRIPT over^ start_ARG italic_R end_ARG start_POSTSUPERSCRIPT ( italic_t , italic_t + italic_δ ) end_POSTSUPERSCRIPT and (C~(t,t+δ)R^(t,t+δ))superscriptsuperscript~𝐶𝑡𝑡𝛿superscript^𝑅𝑡𝑡𝛿top(\widetilde{C}^{(t,t+\delta)}\widehat{R}^{(t,t+\delta)})^{\top}( over~ start_ARG italic_C end_ARG start_POSTSUPERSCRIPT ( italic_t , italic_t + italic_δ ) end_POSTSUPERSCRIPT over^ start_ARG italic_R end_ARG start_POSTSUPERSCRIPT ( italic_t , italic_t + italic_δ ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT ⊤ end_POSTSUPERSCRIPT are both diagonally dominant for all t𝒯\{1}𝑡\𝒯1t\in\mathcal{T}\backslash\{1\}italic_t ∈ caligraphic_T \ { 1 }. If so, we say that the entire sequence of communities in 𝒯𝒯\mathcal{T}caligraphic_T is alignable, which means we can track the evolution of specific nodes and communities across time.

\arabicsection.\arabicsubsection Bias-variance tradeoff for spectral clustering

We first describe the bias-variance decomposition foundational to our work. Let n1(t),,nK(t)superscriptsubscript𝑛1𝑡superscriptsubscript𝑛𝐾𝑡n_{1}^{(t)},\ldots,n_{K}^{(t)}italic_n start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT , … , italic_n start_POSTSUBSCRIPT italic_K end_POSTSUBSCRIPT start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT denote the number of nodes in each community at time t𝑡titalic_t, and nmin(t)=min{n1(t),,nK(t)}superscriptsubscript𝑛𝑡subscriptsuperscript𝑛𝑡1superscriptsubscript𝑛𝐾𝑡n_{\min}^{(t)}=\min\{n^{(t)}_{1},\ldots,n_{K}^{(t)}\}italic_n start_POSTSUBSCRIPT roman_min end_POSTSUBSCRIPT start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT = roman_min { italic_n start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT , … , italic_n start_POSTSUBSCRIPT italic_K end_POSTSUBSCRIPT start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT }. Let Δ(t)K×KsuperscriptΔ𝑡superscript𝐾𝐾\Delta^{(t)}\in\mathbb{R}^{K\times K}roman_Δ start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ∈ blackboard_R start_POSTSUPERSCRIPT italic_K × italic_K end_POSTSUPERSCRIPT denote the diagonal matrix where

diag(Δ(t))={n1(t),,nK(t)}.diagsuperscriptΔ𝑡superscriptsubscript𝑛1𝑡superscriptsubscript𝑛𝐾𝑡\operatorname{{diag}}\big{(}\Delta^{(t)}\big{)}=\big{\{}n_{1}^{(t)},\ldots,n_{% K}^{(t)}\big{\}}.roman_diag ( roman_Δ start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ) = { italic_n start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT , … , italic_n start_POSTSUBSCRIPT italic_K end_POSTSUBSCRIPT start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT } .

Let Π(t)=M(t)(Δ(t))1M(t))\Pi^{(t)}=M^{(t)}(\Delta^{(t)})^{-1}M^{(t)})^{\top}roman_Π start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT = italic_M start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ( roman_Δ start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT - 1 end_POSTSUPERSCRIPT italic_M start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT ⊤ end_POSTSUPERSCRIPT be the projection matrix of the column subspace of M(t)superscript𝑀𝑡M^{(t)}italic_M start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT. Additionally, define the noise matrix X(t)=P(t)A(t)superscript𝑋𝑡superscript𝑃𝑡superscript𝐴𝑡X^{(t)}=P^{(t)}-A^{(t)}italic_X start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT = italic_P start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT - italic_A start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT. Observe the following bias-variance decomposition.

Lemma \arabicsection.\arabictheorem.

Given the model in Section \arabicsection, the following deterministic equality holds,

s𝒮(t;r)(A(s))2D(s)=[s𝒮(t;r)(Q(s))2Π(t)(Q(s))2Π(t)]Isubscript𝑠𝒮𝑡𝑟superscriptsuperscript𝐴𝑠2superscript𝐷𝑠subscriptdelimited-[]subscript𝑠𝒮𝑡𝑟superscriptsuperscript𝑄𝑠2superscriptΠ𝑡superscriptsuperscript𝑄𝑠2superscriptΠ𝑡𝐼\displaystyle\sum_{s\in\mathcal{S}(t;r)}(A^{(s)})^{2}-D^{(s)}=\underbrace{\Big% {[}\sum_{s\in\mathcal{S}(t;r)}(Q^{(s)})^{2}-\Pi^{(t)}(Q^{(s)})^{2}\Pi^{(t)}% \Big{]}}_{I}∑ start_POSTSUBSCRIPT italic_s ∈ caligraphic_S ( italic_t ; italic_r ) end_POSTSUBSCRIPT ( italic_A start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT - italic_D start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT = under⏟ start_ARG [ ∑ start_POSTSUBSCRIPT italic_s ∈ caligraphic_S ( italic_t ; italic_r ) end_POSTSUBSCRIPT ( italic_Q start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT - roman_Π start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ( italic_Q start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT roman_Π start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ] end_ARG start_POSTSUBSCRIPT italic_I end_POSTSUBSCRIPT (\arabicequation)
+[s𝒮(t;r)[diag(Q(t))]2Q(t)diag(Q(t))diag(Q(t))Q(t)]IIsubscriptdelimited-[]subscript𝑠𝒮𝑡𝑟superscriptdelimited-[]diagsuperscript𝑄𝑡2superscript𝑄𝑡diagsuperscript𝑄𝑡diagsuperscript𝑄𝑡superscript𝑄𝑡𝐼𝐼\displaystyle\qquad+\underbrace{\Big{[}\sum_{s\in\mathcal{S}(t;r)}\big{[}% \operatorname{{diag}}(Q^{(t)})\big{]}^{2}-Q^{(t)}\operatorname{{diag}}(Q^{(t)}% )-\operatorname{{diag}}(Q^{(t)})Q^{(t)}\Big{]}}_{II}+ under⏟ start_ARG [ ∑ start_POSTSUBSCRIPT italic_s ∈ caligraphic_S ( italic_t ; italic_r ) end_POSTSUBSCRIPT [ roman_diag ( italic_Q start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ) ] start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT - italic_Q start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT roman_diag ( italic_Q start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ) - roman_diag ( italic_Q start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ) italic_Q start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ] end_ARG start_POSTSUBSCRIPT italic_I italic_I end_POSTSUBSCRIPT
+[s𝒮(t;r)X(s)P(s)+P(s)X(s)]III+[s𝒮(t;r)(X(s))2D(s)]IVsubscriptdelimited-[]subscript𝑠𝒮𝑡𝑟superscript𝑋𝑠superscript𝑃𝑠superscript𝑃𝑠superscript𝑋𝑠𝐼𝐼𝐼subscriptdelimited-[]subscript𝑠𝒮𝑡𝑟superscriptsuperscript𝑋𝑠2superscript𝐷𝑠𝐼𝑉\displaystyle\qquad+\underbrace{\Big{[}\sum_{s\in\mathcal{S}(t;r)}X^{(s)}P^{(s% )}+P^{(s)}X^{(s)}\Big{]}}_{III}+\underbrace{\Big{[}\sum_{s\in\mathcal{S}(t;r)}% (X^{(s)})^{2}-D^{(s)}\Big{]}}_{IV}+ under⏟ start_ARG [ ∑ start_POSTSUBSCRIPT italic_s ∈ caligraphic_S ( italic_t ; italic_r ) end_POSTSUBSCRIPT italic_X start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT italic_P start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT + italic_P start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT italic_X start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT ] end_ARG start_POSTSUBSCRIPT italic_I italic_I italic_I end_POSTSUBSCRIPT + under⏟ start_ARG [ ∑ start_POSTSUBSCRIPT italic_s ∈ caligraphic_S ( italic_t ; italic_r ) end_POSTSUBSCRIPT ( italic_X start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT - italic_D start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT ] end_ARG start_POSTSUBSCRIPT italic_I italic_V end_POSTSUBSCRIPT
+[s𝒮(t;r)Π(t)(Q(s))2Π(t)]V.subscriptdelimited-[]subscript𝑠𝒮𝑡𝑟superscriptΠ𝑡superscriptsuperscript𝑄𝑠2superscriptΠ𝑡𝑉\displaystyle\qquad+\underbrace{\Big{[}\sum_{s\in\mathcal{S}(t;r)}\Pi^{(t)}(Q^% {(s)})^{2}\Pi^{(t)}\Big{]}}_{V}.+ under⏟ start_ARG [ ∑ start_POSTSUBSCRIPT italic_s ∈ caligraphic_S ( italic_t ; italic_r ) end_POSTSUBSCRIPT roman_Π start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ( italic_Q start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT roman_Π start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ] end_ARG start_POSTSUBSCRIPT italic_V end_POSTSUBSCRIPT .

We deem this decomposition as the bias-variance decomposition for dynamic SBMs since term I𝐼Iitalic_I represents the deterministic bias dictated by nodes changing communities, term II𝐼𝐼IIitalic_I italic_I represents the deterministic diagonal bias, term III𝐼𝐼𝐼IIIitalic_I italic_I italic_I represents a random error term centered around 0, term IV𝐼𝑉IVitalic_I italic_V represents the random variance term, and term V𝑉Vitalic_V represents the deterministic signal matrix containing the community information. We note that this decomposition differs from those used in Pensky & Zhang (2019) and Keriven & Vaiter (2022), which instead yield a decomposition that requires smoothness assumptions in {B(t)}superscript𝐵𝑡\{B^{(t)}\}{ italic_B start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT } to derive community-consistency.

\arabicsection.\arabicsubsection Consistency of time-varying communities

In the following, we discuss the assumptions and theoretical guarantees for KD-SoS. We define the following notation. For two sequences ansubscript𝑎𝑛a_{n}italic_a start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT and bnsubscript𝑏𝑛b_{n}italic_b start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT, we define an=O(bn)subscript𝑎𝑛𝑂subscript𝑏𝑛a_{n}=O(b_{n})italic_a start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT = italic_O ( italic_b start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT ), an=o(bn)subscript𝑎𝑛𝑜subscript𝑏𝑛a_{n}=o(b_{n})italic_a start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT = italic_o ( italic_b start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT ), and an=ω(bn)subscript𝑎𝑛𝜔subscript𝑏𝑛a_{n}=\omega(b_{n})italic_a start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT = italic_ω ( italic_b start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT ) to denote ansubscript𝑎𝑛a_{n}italic_a start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT is asymptotically bounded above by bnsubscript𝑏𝑛b_{n}italic_b start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT by a constant, liman/bn=0subscript𝑎𝑛subscript𝑏𝑛0\lim a_{n}/b_{n}=0roman_lim italic_a start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT / italic_b start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT = 0, or liman/bn=subscript𝑎𝑛subscript𝑏𝑛\lim a_{n}/b_{n}=\inftyroman_lim italic_a start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT / italic_b start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT = ∞ respectively. For a symmetric matrix X𝑋Xitalic_X, let λmin(X)subscript𝜆𝑋\lambda_{\min}(X)italic_λ start_POSTSUBSCRIPT roman_min end_POSTSUBSCRIPT ( italic_X ) denote its smallest eigenvalue in absolute value.

{assumption}

[Asymptotic regime] Assume a sequence where n𝑛nitalic_n and T𝑇Titalic_T are increasing, n,T3𝑛𝑇3n,T\geq 3italic_n , italic_T ≥ 3, and Tlog(T)/n=o(1)𝑇𝑇𝑛𝑜1T\log(T)/n=o(1)italic_T roman_log ( italic_T ) / italic_n = italic_o ( 1 ). Additionally, ρnsubscript𝜌𝑛\rho_{n}italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT and γ𝛾\gammaitalic_γ can vary with n𝑛nitalic_n and T𝑇Titalic_T, but there exists a constant c1subscript𝑐1c_{1}italic_c start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT such that nρnc1𝑛subscript𝜌𝑛subscript𝑐1n\rho_{n}\leq c_{1}italic_n italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT ≤ italic_c start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT. Furthermore, assume K𝐾Kitalic_K is fixed.

We codify the membership dynamics described in Section \arabicsection with the following assumption. {assumption}[Independent Poisson community changing rate] Assume for a given community switching rate γ0𝛾0\gamma\geq 0italic_γ ≥ 0, each node changes memberships at random times between t[0,1]𝑡01t\in[0,1]italic_t ∈ [ 0 , 1 ] according to a Poisson(γ)Poisson𝛾\operatorname{{Poisson}}(\gamma)roman_Poisson ( italic_γ ) process, independent of all other nodes.

{assumption}

[Stable community sizes] Assume that across all t[0,1]𝑡01t\in[0,1]italic_t ∈ [ 0 , 1 ] and all communities k{1,,K}𝑘1𝐾k\in\{1,\ldots,K\}italic_k ∈ { 1 , … , italic_K }, there exists a constant c2subscript𝑐2c_{2}italic_c start_POSTSUBSCRIPT 2 end_POSTSUBSCRIPT independent of n,T,γ,ρn𝑛𝑇𝛾subscript𝜌𝑛n,T,\gamma,\rho_{n}italic_n , italic_T , italic_γ , italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT satisfying 1c21subscript𝑐21\leq c_{2}1 ≤ italic_c start_POSTSUBSCRIPT 2 end_POSTSUBSCRIPT such that

{nk(t)[1c2Kn,c2Kn],for all k{1,,K},t𝒯}1ϵc2,n.formulae-sequencesuperscriptsubscript𝑛𝑘𝑡1subscript𝑐2𝐾𝑛subscript𝑐2𝐾𝑛formulae-sequencefor all 𝑘1𝐾𝑡𝒯1subscriptitalic-ϵsubscript𝑐2𝑛\mathbb{P}\left\{n_{k}^{(t)}\in\Big{[}\frac{1}{c_{2}K}\cdot n,\;\frac{c_{2}}{K% }\cdot n\Big{]},\quad\text{for all }k\in\{1,\ldots,K\},\;t\in\mathcal{T}\right% \}\geq 1-\epsilon_{c_{2},n}.blackboard_P { italic_n start_POSTSUBSCRIPT italic_k end_POSTSUBSCRIPT start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ∈ [ divide start_ARG 1 end_ARG start_ARG italic_c start_POSTSUBSCRIPT 2 end_POSTSUBSCRIPT italic_K end_ARG ⋅ italic_n , divide start_ARG italic_c start_POSTSUBSCRIPT 2 end_POSTSUBSCRIPT end_ARG start_ARG italic_K end_ARG ⋅ italic_n ] , for all italic_k ∈ { 1 , … , italic_K } , italic_t ∈ caligraphic_T } ≥ 1 - italic_ϵ start_POSTSUBSCRIPT italic_c start_POSTSUBSCRIPT 2 end_POSTSUBSCRIPT , italic_n end_POSTSUBSCRIPT .

for some ϵc2,n0subscriptitalic-ϵsubscript𝑐2𝑛0\epsilon_{c_{2},n}\rightarrow 0italic_ϵ start_POSTSUBSCRIPT italic_c start_POSTSUBSCRIPT 2 end_POSTSUBSCRIPT , italic_n end_POSTSUBSCRIPT → 0.

{assumption}

[Minimum eigenvalue of aggregated connectivity matrix] Assume that the sequence {B(t)}superscript𝐵𝑡\{B^{(t)}\}{ italic_B start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT } from t[0,1]𝑡01t\in[0,1]italic_t ∈ [ 0 , 1 ] is fixed and is an integrable process across each (i,j){1,,K}2𝑖𝑗superscript1𝐾2(i,j)\in\{1,\ldots,K\}^{2}( italic_i , italic_j ) ∈ { 1 , … , italic_K } start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT coordinate. Additionally, for a chosen δ>0𝛿0\delta>0italic_δ > 0, we define

cδ=mint1,t2[0,1],t2t12δλmin(1t2t1s=t1t2(B(s))2𝑑s)0.subscript𝑐𝛿subscriptsubscript𝑡1subscript𝑡201subscript𝑡2subscript𝑡12𝛿subscript𝜆1subscript𝑡2subscript𝑡1superscriptsubscript𝑠subscript𝑡1subscript𝑡2superscriptsuperscript𝐵𝑠2differential-d𝑠0c_{\delta}=\min_{\begin{subarray}{c}t_{1},t_{2}\in[0,1],\\ t_{2}-t_{1}\geq 2\delta\end{subarray}}\lambda_{\min}\Big{(}\frac{1}{t_{2}-t_{1% }}\int_{s=t_{1}}^{t_{2}}(B^{(s)})^{2}ds\Big{)}\geq 0.italic_c start_POSTSUBSCRIPT italic_δ end_POSTSUBSCRIPT = roman_min start_POSTSUBSCRIPT start_ARG start_ROW start_CELL italic_t start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT , italic_t start_POSTSUBSCRIPT 2 end_POSTSUBSCRIPT ∈ [ 0 , 1 ] , end_CELL end_ROW start_ROW start_CELL italic_t start_POSTSUBSCRIPT 2 end_POSTSUBSCRIPT - italic_t start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT ≥ 2 italic_δ end_CELL end_ROW end_ARG end_POSTSUBSCRIPT italic_λ start_POSTSUBSCRIPT roman_min end_POSTSUBSCRIPT ( divide start_ARG 1 end_ARG start_ARG italic_t start_POSTSUBSCRIPT 2 end_POSTSUBSCRIPT - italic_t start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT end_ARG ∫ start_POSTSUBSCRIPT italic_s = italic_t start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT end_POSTSUBSCRIPT start_POSTSUPERSCRIPT italic_t start_POSTSUBSCRIPT 2 end_POSTSUBSCRIPT end_POSTSUPERSCRIPT ( italic_B start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT italic_d italic_s ) ≥ 0 .
{assumption}

[Alignability] Assume that along the sequence of γ𝛾\gammaitalic_γ and T𝑇Titalic_T,

γ/T=o(1).𝛾𝑇𝑜1\gamma/T=o(1).italic_γ / italic_T = italic_o ( 1 ) . (\arabicequation)
Remark \arabicsection.\arabictheorem (Additional remark for Assumption \arabicsection.\arabicsubsection).

Assumption \arabicsection.\arabicsubsection extends the balanced community size condition from a single time point to a uniform version across all time points. It serves two purposes: First, this condition is needed to control the error bound in each single time point. Second, when combined with Assumption \arabicsection.\arabicsubsection, it guarantees alignability of estimated communities across time. The exact relationship between c2subscript𝑐2c_{2}italic_c start_POSTSUBSCRIPT 2 end_POSTSUBSCRIPT and ϵc2,nsubscriptitalic-ϵsubscript𝑐2𝑛\epsilon_{c_{2},n}italic_ϵ start_POSTSUBSCRIPT italic_c start_POSTSUBSCRIPT 2 end_POSTSUBSCRIPT , italic_n end_POSTSUBSCRIPT depends on the switching rate γ𝛾\gammaitalic_γ, as well as the transition probabilities between communities when a node changes membership. This assumption precludes the scenario where some communities vanish as nodes are more likely to move out than move in. Under certain common conditions of the transition probabilities, such as mixing, Assumption \arabicsection.\arabicsubsection can hold using concentration inequalities and union bound. We provide a concrete example in Section \arabicsection.\arabicsubsection below.

Remark \arabicsection.\arabictheorem (Additional remark for Assumption \arabicsection.\arabicsubsection).

Assumption \arabicsection.\arabicsubsection states that column space of the matrices {(B(t))2}superscriptsuperscript𝐵𝑡2\{(B^{(t)})^{2}\}{ ( italic_B start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT } should span enough of Ksuperscript𝐾\mathbb{R}^{K}blackboard_R start_POSTSUPERSCRIPT italic_K end_POSTSUPERSCRIPT in an average sense among all t[t1,t2]𝑡subscript𝑡1subscript𝑡2t\in[t_{1},t_{2}]italic_t ∈ [ italic_t start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT , italic_t start_POSTSUBSCRIPT 2 end_POSTSUBSCRIPT ]. That is, B(t)superscript𝐵𝑡B^{(t)}italic_B start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT can be rank deficient for any particular t[t1,t2]𝑡subscript𝑡1subscript𝑡2t\in[t_{1},t_{2}]italic_t ∈ [ italic_t start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT , italic_t start_POSTSUBSCRIPT 2 end_POSTSUBSCRIPT ], but as long as δ𝛿\deltaitalic_δ is large enough, the average of {(B(t))2}superscriptsuperscript𝐵𝑡2\{(B^{(t)})^{2}\}{ ( italic_B start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT } is full rank. As we will discuss later, cδsubscript𝑐𝛿c_{\delta}italic_c start_POSTSUBSCRIPT italic_δ end_POSTSUBSCRIPT has a nuanced relation with our bandwidth r𝑟ritalic_r and the consistency of our estimator – estimating the community structure consistently for each time t𝑡titalic_t will be difficult if we choose a bandwidth r=δ𝑟𝛿r=\deltaitalic_r = italic_δ where cδ0subscript𝑐𝛿0c_{\delta}\approx 0italic_c start_POSTSUBSCRIPT italic_δ end_POSTSUBSCRIPT ≈ 0.

Remark \arabicsection.\arabictheorem (Additional remark for Assumption \arabicsection.\arabicsubsection).

As we will show later in Section \arabicsection.\arabicsubsection, Assumption \arabicsection.\arabicsubsection is a label permutation identifiability assumption. Without it, KD-SoS can still estimate each network’s community structure. However, it would be difficult to align the communities across time, where “alignablility” will be defined later as the main focus of Section \arabicsection.\arabicsubsection. Recall that since each node changes memberships independently of one another according to the Poisson(λ𝜆\lambdaitalic_λ) process, the expected number of nodes to change memberships within a time interval of 1/T1𝑇1/T1 / italic_T (i.e., the time elapsed between two consecutively observed networks) is roughly nγ/T𝑛𝛾𝑇n\gamma/Titalic_n italic_γ / italic_T if γ/T1less-than-or-similar-to𝛾𝑇1\gamma/T\lesssim 1italic_γ / italic_T ≲ 1. Combined with Assumption \arabicsection.\arabicsubsection, a more explicit equivalent statement of (\arabicequation) is

nγ/T=o(n/K).𝑛𝛾𝑇𝑜𝑛𝐾n\gamma/T=o(n/K).italic_n italic_γ / italic_T = italic_o ( italic_n / italic_K ) .

This demonstrates the intuition that the networks’ communities are alignable across time if the number of changes between consecutive networks is less than the smallest community size.

Provided these assumptions, KD-SoS’s estimated communities have the following pointwise relative Hamming estimation error for the network at time t𝒯𝑡𝒯t\in\mathcal{T}italic_t ∈ caligraphic_T. Let the function (x)+subscript𝑥(x)_{+}( italic_x ) start_POSTSUBSCRIPT + end_POSTSUBSCRIPT denote min{0,x}0𝑥\min\{0,x\}roman_min { 0 , italic_x }.

Theorem \arabicsection.\arabictheorem.

Given Assumptions \arabicsection.\arabicsubsection, \arabicsection.\arabicsubsection, \arabicsection.\arabicsubsection, and \arabicsection.\arabicsubsection for the model in Section \arabicsection, or a bandwidth r[0,1]𝑟01r\in[0,1]italic_r ∈ [ 0 , 1 ] satisfying (rT+1)1/2nρnc3log1/2(rT+n+1)superscript𝑟𝑇112𝑛subscript𝜌𝑛subscript𝑐3superscript12𝑟𝑇𝑛1(rT+1)^{1/2}n\rho_{n}\geq c_{3}\log^{1/2}(rT+n+1)( italic_r italic_T + 1 ) start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT italic_n italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT ≥ italic_c start_POSTSUBSCRIPT 3 end_POSTSUBSCRIPT roman_log start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT ( italic_r italic_T + italic_n + 1 ) for some constant c3>1subscript𝑐31c_{3}>1italic_c start_POSTSUBSCRIPT 3 end_POSTSUBSCRIPT > 1, then at any particular t𝒯𝑡𝒯t\in\mathcal{T}italic_t ∈ caligraphic_T,

L(G(t),G^(t))c1(1(γr+log(n)/n)1/2)+2(γr+log(n)n+1n2+log(rT+n)rTn2ρn2),𝐿superscript𝐺𝑡superscript^𝐺𝑡𝑐1subscriptsuperscript1superscript𝛾𝑟𝑛𝑛122𝛾𝑟𝑛𝑛1superscript𝑛2𝑟𝑇𝑛𝑟𝑇superscript𝑛2superscriptsubscript𝜌𝑛2L\big{(}G^{(t)},\widehat{G}^{(t)}\big{)}\leq c\cdot\frac{1}{(1-(\gamma r+\log(% n)/n)^{1/2})^{2}_{+}}\cdot\Big{(}\gamma r+\frac{\log(n)}{n}+\frac{1}{n^{2}}+% \frac{\log(rT+n)}{rTn^{2}\rho_{n}^{2}}\Big{)},italic_L ( italic_G start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT , over^ start_ARG italic_G end_ARG start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ) ≤ italic_c ⋅ divide start_ARG 1 end_ARG start_ARG ( 1 - ( italic_γ italic_r + roman_log ( italic_n ) / italic_n ) start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT start_POSTSUBSCRIPT + end_POSTSUBSCRIPT end_ARG ⋅ ( italic_γ italic_r + divide start_ARG roman_log ( italic_n ) end_ARG start_ARG italic_n end_ARG + divide start_ARG 1 end_ARG start_ARG italic_n start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT end_ARG + divide start_ARG roman_log ( italic_r italic_T + italic_n ) end_ARG start_ARG italic_r italic_T italic_n start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT end_ARG ) , (\arabicequation)

with probability at least 1O((rT+n)1)ϵc2,n1𝑂superscript𝑟𝑇𝑛1subscriptitalic-ϵsubscript𝑐2𝑛1-O((rT+n)^{-1})-\epsilon_{c_{2},n}1 - italic_O ( ( italic_r italic_T + italic_n ) start_POSTSUPERSCRIPT - 1 end_POSTSUPERSCRIPT ) - italic_ϵ start_POSTSUBSCRIPT italic_c start_POSTSUBSCRIPT 2 end_POSTSUBSCRIPT , italic_n end_POSTSUBSCRIPT for some constant c>0𝑐0c>0italic_c > 0 that depends on c1subscript𝑐1c_{1}italic_c start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT, c2subscript𝑐2c_{2}italic_c start_POSTSUBSCRIPT 2 end_POSTSUBSCRIPT, c3subscript𝑐3c_{3}italic_c start_POSTSUBSCRIPT 3 end_POSTSUBSCRIPT, cδsubscript𝑐𝛿c_{\delta}italic_c start_POSTSUBSCRIPT italic_δ end_POSTSUBSCRIPT, and K𝐾Kitalic_K.

Observe that if γr𝛾𝑟\gamma ritalic_γ italic_r is close to 1 or larger, then our bound in Theorem \arabicsection.\arabictheorem is vacuously true since L(G(t),G^(t))𝐿superscript𝐺𝑡superscript^𝐺𝑡L(G^{(t)},\widehat{G}^{(t)})italic_L ( italic_G start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT , over^ start_ARG italic_G end_ARG start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ) has to be less than 1, see (\arabicequation). Notably, Assumption \arabicsection.\arabicsubsection is not needed to estimate the community structure of a particular network consistently, but we discuss its importance in the next section.

Remark \arabicsection.\arabictheorem (Explicit relation between r𝑟ritalic_r and minimal eigenvalue in Assumption \arabicsection.\arabicsubsection).

We expand upon Remark \arabicsection.\arabictheorem. In Theorem \arabicsection.\arabictheorem, we had stated the bandwidth r𝑟ritalic_r distinctly from the bandwidth δ𝛿\deltaitalic_δ used to define the minimum eigenvalue cδsubscript𝑐𝛿c_{\delta}italic_c start_POSTSUBSCRIPT italic_δ end_POSTSUBSCRIPT stated in Assumption \arabicsection.\arabicsubsection for simplicity of exposition. We can derive a similar theorem where both bandwidths are the same, i.e., r=δ𝑟𝛿r=\deltaitalic_r = italic_δ. This is because the minimum eigenvalue cδsubscript𝑐𝛿c_{\delta}italic_c start_POSTSUBSCRIPT italic_δ end_POSTSUBSCRIPT only appears in the denominator when applying Davis-Kahan. Hence, we can rewrite RHS of (\arabicequation) to explicitly include the dependency on cδsubscript𝑐𝛿c_{\delta}italic_c start_POSTSUBSCRIPT italic_δ end_POSTSUBSCRIPT, which would result in an upper bound proportional to

1cδ2(1(γr+log(n)/n)1/2)+2(γr+log(n)n+1n2+log(rT+n)rTn2ρn2).1superscriptsubscript𝑐𝛿2subscriptsuperscript1superscript𝛾𝑟𝑛𝑛122𝛾𝑟𝑛𝑛1superscript𝑛2𝑟𝑇𝑛𝑟𝑇superscript𝑛2superscriptsubscript𝜌𝑛2\frac{1}{c_{\delta}^{2}\cdot(1-(\gamma r+\log(n)/n)^{1/2})^{2}_{+}}\cdot\Big{(% }\gamma r+\frac{\log(n)}{n}+\frac{1}{n^{2}}+\frac{\log(rT+n)}{rTn^{2}\rho_{n}^% {2}}\Big{)}.divide start_ARG 1 end_ARG start_ARG italic_c start_POSTSUBSCRIPT italic_δ end_POSTSUBSCRIPT start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT ⋅ ( 1 - ( italic_γ italic_r + roman_log ( italic_n ) / italic_n ) start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT start_POSTSUBSCRIPT + end_POSTSUBSCRIPT end_ARG ⋅ ( italic_γ italic_r + divide start_ARG roman_log ( italic_n ) end_ARG start_ARG italic_n end_ARG + divide start_ARG 1 end_ARG start_ARG italic_n start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT end_ARG + divide start_ARG roman_log ( italic_r italic_T + italic_n ) end_ARG start_ARG italic_r italic_T italic_n start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT end_ARG ) .

If cδ=0subscript𝑐𝛿0c_{\delta}=0italic_c start_POSTSUBSCRIPT italic_δ end_POSTSUBSCRIPT = 0, the above equation would equal infinity, yielding a vacuously true upper bound.

We now derive an upper bound for the relative Hamming error when we use the near-optimal bandwidth r𝑟ritalic_r.

Corollary \arabicsection.\arabictheorem (Near-optimal bandwidth).

Consider the setting in Theorem \arabicsection.\arabictheorem with the bandwidth

r*=min{c1(γT)1/2nρn,1},superscript𝑟𝑐1superscript𝛾𝑇12𝑛subscript𝜌𝑛1r^{*}=\min\Big{\{}c\cdot\frac{1}{(\gamma T)^{1/2}n\rho_{n}},1\Big{\}},italic_r start_POSTSUPERSCRIPT * end_POSTSUPERSCRIPT = roman_min { italic_c ⋅ divide start_ARG 1 end_ARG start_ARG ( italic_γ italic_T ) start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT italic_n italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT end_ARG , 1 } ,

for some constant c>0𝑐0c>0italic_c > 0 that depends on c1subscript𝑐1c_{1}italic_c start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT, c2subscript𝑐2c_{2}italic_c start_POSTSUBSCRIPT 2 end_POSTSUBSCRIPT, c3subscript𝑐3c_{3}italic_c start_POSTSUBSCRIPT 3 end_POSTSUBSCRIPT, cδsubscript𝑐𝛿c_{\delta}italic_c start_POSTSUBSCRIPT italic_δ end_POSTSUBSCRIPT, and K𝐾Kitalic_K. If the asymptotic setting satisfies

γr*=γT1nρn1,𝛾superscript𝑟𝛾𝑇1𝑛subscript𝜌𝑛much-less-than1\gamma r^{*}=\sqrt{\frac{\gamma}{T}}\cdot\frac{1}{n\rho_{n}}\ll 1,italic_γ italic_r start_POSTSUPERSCRIPT * end_POSTSUPERSCRIPT = square-root start_ARG divide start_ARG italic_γ end_ARG start_ARG italic_T end_ARG end_ARG ⋅ divide start_ARG 1 end_ARG start_ARG italic_n italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT end_ARG ≪ 1 ,

then the bandwidth r*superscript𝑟r^{*}italic_r start_POSTSUPERSCRIPT * end_POSTSUPERSCRIPT minimizes the rate in Theorem \arabicsection.\arabictheorem up to logarithmic factors.

Observe that r*superscript𝑟r^{*}italic_r start_POSTSUPERSCRIPT * end_POSTSUPERSCRIPT in Corollary \arabicsection.\arabictheorem captures an intuitive behavior. If the number of nodes n𝑛nitalic_n or network density ρnsubscript𝜌𝑛\rho_{n}italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT increases, then there is more signal in each network, reducing the bandwidth r*superscript𝑟r^{*}italic_r start_POSTSUPERSCRIPT * end_POSTSUPERSCRIPT. If the community switching rate γ𝛾\gammaitalic_γ increases, there is less incentive to aggregate across networks, reducing r*superscript𝑟r^{*}italic_r start_POSTSUPERSCRIPT * end_POSTSUPERSCRIPT. Loosely speaking, observe that box kernel roughly averages over O(r*T)𝑂superscript𝑟𝑇O(r^{*}T)italic_O ( italic_r start_POSTSUPERSCRIPT * end_POSTSUPERSCRIPT italic_T ) networks, meaning that the number of networks relevant for computing the community structure of network t𝑡titalic_t is approximately O(T)𝑂𝑇O(\sqrt{T})italic_O ( square-root start_ARG italic_T end_ARG ) networks if γ𝛾\gammaitalic_γ and nρn𝑛subscript𝜌𝑛n\rho_{n}italic_n italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT (the expected number of edges per node) are held constant. This means the bandwidth grows slower than the total number of networks T𝑇Titalic_T, which is reasonable. Next, we state the resulting relative Hamming error stemming from this choice of bandwidth r*superscript𝑟r^{*}italic_r start_POSTSUPERSCRIPT * end_POSTSUPERSCRIPT. In particular, we are interested in two regimes based on whether r*1superscript𝑟1r^{*}\rightarrow 1italic_r start_POSTSUPERSCRIPT * end_POSTSUPERSCRIPT → 1 (i.e., averaging across all T𝑇Titalic_T networks asymptotically) or r*0superscript𝑟0r^{*}\rightarrow 0italic_r start_POSTSUPERSCRIPT * end_POSTSUPERSCRIPT → 0 (i.e., averaging across a smaller and smaller proportion of the T𝑇Titalic_T networks asymptotically).

Corollary \arabicsection.\arabictheorem (Slow community-changing regime).

Given Assumptions \arabicsection.\arabicsubsection, \arabicsection.\arabicsubsection, \arabicsection.\arabicsubsection, and \arabicsection.\arabicsubsection for the model in Section \arabicsection, and bandwidth r*superscript𝑟r^{*}italic_r start_POSTSUPERSCRIPT * end_POSTSUPERSCRIPT defined in Corollary \arabicsection.\arabictheorem, consider an asymptotic sequence of {n,T,γ,ρn}𝑛𝑇𝛾subscript𝜌𝑛\{n,T,\gamma,\rho_{n}\}{ italic_n , italic_T , italic_γ , italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT } where

γ0,𝑎𝑛𝑑T1/2nρn=ω(log1/2(T+n)).formulae-sequence𝛾0𝑎𝑛𝑑superscript𝑇12𝑛subscript𝜌𝑛𝜔superscript12𝑇𝑛\gamma\rightarrow 0,\quad\text{and}\quad T^{1/2}n\rho_{n}=\omega\big{(}\log^{1% /2}(T+n)\big{)}.italic_γ → 0 , and italic_T start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT italic_n italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT = italic_ω ( roman_log start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT ( italic_T + italic_n ) ) . (\arabicequation)

In this setting, r*1normal-→superscript𝑟1r^{*}\rightarrow 1italic_r start_POSTSUPERSCRIPT * end_POSTSUPERSCRIPT → 1 and KD-SoS has a relative Hamming error of

L(G(t),G^(t))=O(γ+log(n)n+1n2+log(T+n)T(nρn)2)0,𝐿superscript𝐺𝑡superscript^𝐺𝑡𝑂𝛾𝑛𝑛1superscript𝑛2𝑇𝑛𝑇superscript𝑛subscript𝜌𝑛20L\Big{(}G^{(t)},\widehat{G}^{(t)}\Big{)}=O\Big{(}\gamma+\frac{\log(n)}{n}+% \frac{1}{n^{2}}+\frac{\log(T+n)}{T(n\rho_{n})^{2}}\Big{)}\rightarrow 0,italic_L ( italic_G start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT , over^ start_ARG italic_G end_ARG start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ) = italic_O ( italic_γ + divide start_ARG roman_log ( italic_n ) end_ARG start_ARG italic_n end_ARG + divide start_ARG 1 end_ARG start_ARG italic_n start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT end_ARG + divide start_ARG roman_log ( italic_T + italic_n ) end_ARG start_ARG italic_T ( italic_n italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT ) start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT end_ARG ) → 0 ,

with probability 1O((T+n)1)1𝑂superscript𝑇𝑛11-O((T+n)^{-1})1 - italic_O ( ( italic_T + italic_n ) start_POSTSUPERSCRIPT - 1 end_POSTSUPERSCRIPT ) for any particular t𝒯𝑡𝒯t\in\mathcal{T}italic_t ∈ caligraphic_T.

Corollary \arabicsection.\arabictheorem (Fast community-changing regime).

Given Assumptions \arabicsection.\arabicsubsection, \arabicsection.\arabicsubsection, \arabicsection.\arabicsubsection, and \arabicsection.\arabicsubsection, for the model in Section \arabicsection, and bandwidth r*superscript𝑟r^{*}italic_r start_POSTSUPERSCRIPT * end_POSTSUPERSCRIPT defined in Corollary \arabicsection.\arabictheorem, consider an asymptotic sequence of {n,T,γ,ρn}𝑛𝑇𝛾subscript𝜌𝑛\{n,T,\gamma,\rho_{n}\}{ italic_n , italic_T , italic_γ , italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT } where

γ=ω(1),𝑎𝑛𝑑γ=o(T(nρn)2log(T+n)).formulae-sequence𝛾𝜔1𝑎𝑛𝑑𝛾𝑜𝑇superscript𝑛subscript𝜌𝑛2𝑇𝑛\gamma=\omega(1)\,,\quad\text{and}\quad\gamma=o\Big{(}\frac{T(n\rho_{n})^{2}}{% \log(T+n)}\Big{)}.italic_γ = italic_ω ( 1 ) , and italic_γ = italic_o ( divide start_ARG italic_T ( italic_n italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT ) start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT end_ARG start_ARG roman_log ( italic_T + italic_n ) end_ARG ) . (\arabicequation)

In this setting, r*0normal-→superscript𝑟0r^{*}\rightarrow 0italic_r start_POSTSUPERSCRIPT * end_POSTSUPERSCRIPT → 0 and KD-SoS has a relative Hamming error of

L(G(t),G^(t))=O(γ1/2T1/2nρn+log(n)n+1n2+γ1/2log(T1/2/(γ1/2nρn)+n)T1/2nρn)0,𝐿superscript𝐺𝑡superscript^𝐺𝑡𝑂superscript𝛾12superscript𝑇12𝑛subscript𝜌𝑛𝑛𝑛1superscript𝑛2superscript𝛾12superscript𝑇12superscript𝛾12𝑛subscript𝜌𝑛𝑛superscript𝑇12𝑛subscript𝜌𝑛0L\Big{(}G^{(t)},\widehat{G}^{(t)}\Big{)}=O\Big{(}\frac{\gamma^{1/2}}{T^{1/2}n% \rho_{n}}+\frac{\log(n)}{n}+\frac{1}{n^{2}}+\frac{\gamma^{1/2}\log\big{(}T^{1/% 2}/(\gamma^{1/2}n\rho_{n})+n\big{)}}{T^{1/2}n\rho_{n}}\Big{)}\rightarrow 0,italic_L ( italic_G start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT , over^ start_ARG italic_G end_ARG start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ) = italic_O ( divide start_ARG italic_γ start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT end_ARG start_ARG italic_T start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT italic_n italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT end_ARG + divide start_ARG roman_log ( italic_n ) end_ARG start_ARG italic_n end_ARG + divide start_ARG 1 end_ARG start_ARG italic_n start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT end_ARG + divide start_ARG italic_γ start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT roman_log ( italic_T start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT / ( italic_γ start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT italic_n italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT ) + italic_n ) end_ARG start_ARG italic_T start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT italic_n italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT end_ARG ) → 0 ,

with probability 1O((T+n)1)1𝑂superscript𝑇𝑛11-O((T+n)^{-1})1 - italic_O ( ( italic_T + italic_n ) start_POSTSUPERSCRIPT - 1 end_POSTSUPERSCRIPT ) for any particular t𝒯𝑡𝒯t\in\mathcal{T}italic_t ∈ caligraphic_T.

Observe that the two conditions (\arabicequation) and (\arabicequation) dichotomize the settings in a “slow community switching regime” and a “fast community switching regime” respectively. In the former setting, the nodes become less likely to change communities along the asymptotic sequence of {n,T,γ,ρn}𝑛𝑇𝛾subscript𝜌𝑛\{n,T,\gamma,\rho_{n}\}{ italic_n , italic_T , italic_γ , italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT }, eventually resulting in KD-SoS averaging over all T𝑇Titalic_T networks. In this regime Corollary \arabicsection.\arabictheorem concurs with the recent results in static multi-layer SBM (Lei et al., 2020; Lei & Lin, 2022; Lei et al., 2023), which imply that T1/2nρnlog1/2(T+n)much-greater-thansuperscript𝑇12𝑛subscript𝜌𝑛superscript12𝑇𝑛T^{1/2}n\rho_{n}\gg\log^{1/2}(T+n)italic_T start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT italic_n italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT ≫ roman_log start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT ( italic_T + italic_n ) is nearly necessary, up to logarithm factors, for consistent community estimation. In the latter setting, the bandwidth converges to 0 due to the nodes changing communities too quickly relative to the other parameters T𝑇Titalic_T, n𝑛nitalic_n, and ρnsubscript𝜌𝑛\rho_{n}italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT. Observe that if nρn=log1/2(T+n)𝑛subscript𝜌𝑛superscript12𝑇𝑛n\rho_{n}=\log^{1/2}(T+n)italic_n italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT = roman_log start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT ( italic_T + italic_n ), then (\arabicequation) is equivalent to γ/T=o(1)𝛾𝑇𝑜1\gamma/T=o(1)italic_γ / italic_T = italic_o ( 1 ), which is the requirement posed in Assumption \arabicsection.\arabicsubsection. This further upper-bounds how often nodes can change communities relative to the total number of networks T𝑇Titalic_T. As we will show in the next section, though, this requirement is not just for consistent estimation of a network’s community structure but also for ensuring the alignability of the communities across the T𝑇Titalic_T networks.

\arabicsection.\arabicsubsection Identifiability bound for aligning communities across time

While Theorem \arabicsection.\arabictheorem proves consistent estimation of the community structure at each time t𝑡titalic_t, we now turn our attention towards proving that estimated community structure at each time t𝑡titalic_t can be aligned to those at the previous time s=t1/T𝑠𝑡1𝑇s=t-1/Titalic_s = italic_t - 1 / italic_T. This is an important but separate concern from the consistency proven in Theorem \arabicsection.\arabictheorem since we strive to track how individual communities evolve over time. Our estimator uses the Hungarian assignment (\arabicequation) to align communities across time since the K-mean clusterings return unordered memberships. For this section, we will work under the pretense that for a sequence of membership matrices M(1/T),M(2/T),,M(1)superscript𝑀1𝑇superscript𝑀2𝑇superscript𝑀1M^{(1/T)},M^{(2/T)},\ldots,M^{(1)}italic_M start_POSTSUPERSCRIPT ( 1 / italic_T ) end_POSTSUPERSCRIPT , italic_M start_POSTSUPERSCRIPT ( 2 / italic_T ) end_POSTSUPERSCRIPT , … , italic_M start_POSTSUPERSCRIPT ( 1 ) end_POSTSUPERSCRIPT, we have already applied Hungarian assignment to each consecutive pair of membership matrices to optimally permute the column order. Our discussion of alignability here will show that even after this column permutation, there could still be detrimental ambiguity on how to track individual communities over time. As alluded to in Section \arabicsection.\arabicsubsection, we prove how alignability of communities across time is related to Assumption \arabicsection.\arabicsubsection. We define it formally below.

Definition \arabicsection.\arabictheorem (Alignability of memberships across time).

Let M(1/T)superscript𝑀1𝑇M^{(1/T)}italic_M start_POSTSUPERSCRIPT ( 1 / italic_T ) end_POSTSUPERSCRIPT, M(2/T)superscript𝑀2𝑇M^{(2/T)}italic_M start_POSTSUPERSCRIPT ( 2 / italic_T ) end_POSTSUPERSCRIPT, ,M(1)normal-…superscript𝑀1\ldots,~{}M^{(1)}… , italic_M start_POSTSUPERSCRIPT ( 1 ) end_POSTSUPERSCRIPT denote T𝑇Titalic_T membership matrices. We say the sequence of memberships are alignable if

C(M(t),M(t+1/T))𝑎𝑛𝑑(C(M(t+1/T),M(t)))are both diagonally dominant𝐶superscript𝑀𝑡superscript𝑀𝑡1𝑇𝑎𝑛𝑑𝐶superscript𝑀𝑡1𝑇superscript𝑀𝑡are both diagonally dominantC(M^{(t)},M^{(t+1/T)})\quad\text{and}\quad\big{(}C(M^{(t+1/T)},M^{(t)})\big{)}% \quad\text{are both diagonally dominant}italic_C ( italic_M start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT , italic_M start_POSTSUPERSCRIPT ( italic_t + 1 / italic_T ) end_POSTSUPERSCRIPT ) and ( italic_C ( italic_M start_POSTSUPERSCRIPT ( italic_t + 1 / italic_T ) end_POSTSUPERSCRIPT , italic_M start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ) ) are both diagonally dominant

for all t{1/T,2/T,,(T1)/T}𝑡1𝑇2𝑇normal-…𝑇1𝑇t\in\{1/T,2/T,\ldots,(T-1)/T\}italic_t ∈ { 1 / italic_T , 2 / italic_T , … , ( italic_T - 1 ) / italic_T }, where the confusion matrices C(M(t),M(t+1/T))𝐶superscript𝑀𝑡superscript𝑀𝑡1𝑇C(M^{(t)},M^{(t+1/T)})italic_C ( italic_M start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT , italic_M start_POSTSUPERSCRIPT ( italic_t + 1 / italic_T ) end_POSTSUPERSCRIPT ) are defined in (\arabicequation).

We view M(1/T),M(2/T),,M(1)superscript𝑀1𝑇superscript𝑀2𝑇superscript𝑀1M^{(1/T)},M^{(2/T)},\ldots,M^{(1)}italic_M start_POSTSUPERSCRIPT ( 1 / italic_T ) end_POSTSUPERSCRIPT , italic_M start_POSTSUPERSCRIPT ( 2 / italic_T ) end_POSTSUPERSCRIPT , … , italic_M start_POSTSUPERSCRIPT ( 1 ) end_POSTSUPERSCRIPT as the “true” membership matrices that encode the time-varying community structure that we wish to estimate, even though these are technically random matrices. From the data-generative point of view, alignability implies that R(t,t+1/T)=IKsuperscript𝑅𝑡𝑡1𝑇subscript𝐼𝐾R^{(t,t+1/T)}=I_{K}italic_R start_POSTSUPERSCRIPT ( italic_t , italic_t + 1 / italic_T ) end_POSTSUPERSCRIPT = italic_I start_POSTSUBSCRIPT italic_K end_POSTSUBSCRIPT defined in (\arabicequation) for all t𝑡titalic_t. Indeed, for times t𝑡titalic_t and t+1/T𝑡1𝑇t+1/Titalic_t + 1 / italic_T, if the optimal assignment between the unobserved communities M(t)superscript𝑀𝑡M^{(t)}italic_M start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT and M(t+1/T)superscript𝑀𝑡1𝑇M^{(t+1/T)}italic_M start_POSTSUPERSCRIPT ( italic_t + 1 / italic_T ) end_POSTSUPERSCRIPT is not the identity, then there is no hope of recovering the alignment of the estimated communities consistently. Hence, intuitively, alignability requires that nodes do not switch memberships too quickly, relative to the amount of time between consecutive networks, 1/T1𝑇1/T1 / italic_T.

Below, we first prove that when γ𝛾\gammaitalic_γ is in a regime that violates Assumption \arabicsection.\arabicsubsection, there always exists a non-vanishing probability that T𝑇Titalic_T networks can not be aligned. Later, we prove that when γ𝛾\gammaitalic_γ is in a regime that satisfies Assumption \arabicsection.\arabicsubsection for specifically a two-community model, then all T𝑇Titalic_T networks are alignability with high probability. Since tracking the community sizes over time under Assumption \arabicsection.\arabicsubsection involves specifying the transition probabilities and the number of times such transition occurs in a single time interval, to simplify the discussion in this subsection, we will consider an alternative discrete approximation of Assumption \arabicsection.\arabicsubsection.

{assumption}

[Discrete approximation of Assumption \arabicsection.\arabicsubsection] For each t𝒯\{1}𝑡\𝒯1t\in\mathcal{T}\backslash\{1\}italic_t ∈ caligraphic_T \ { 1 }, each node changes its community membership from time t𝑡titalic_t to t+1/T𝑡1𝑇t+1/Titalic_t + 1 / italic_T independently with probability γ/T𝛾𝑇\gamma/Titalic_γ / italic_T.

Proposition \arabicsection.\arabictheorem (Lack of alignability).

Given Assumptions \arabicsection.\arabicsubsection and \arabicsection.\arabictheorem for the model in Section \arabicsection, if

γTlog[(112((2n)1/2T1)1/n)1],𝛾𝑇superscript112superscriptsuperscript2𝑛12𝑇11𝑛1\gamma\geq T\cdot\log\bigg{[}\bigg{(}1-\frac{1}{2}\cdot\Big{(}\frac{(2n)^{1/2}% }{T-1}\Big{)}^{1/n}\bigg{)}^{-1}\bigg{]},italic_γ ≥ italic_T ⋅ roman_log [ ( 1 - divide start_ARG 1 end_ARG start_ARG 2 end_ARG ⋅ ( divide start_ARG ( 2 italic_n ) start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT end_ARG start_ARG italic_T - 1 end_ARG ) start_POSTSUPERSCRIPT 1 / italic_n end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT - 1 end_POSTSUPERSCRIPT ] ,

then the probability that the set of random membership matrices M(1/T),M(2/T),,M(1)superscript𝑀1𝑇superscript𝑀2𝑇normal-…superscript𝑀1M^{(1/T)},M^{(2/T)},\ldots,M^{(1)}italic_M start_POSTSUPERSCRIPT ( 1 / italic_T ) end_POSTSUPERSCRIPT , italic_M start_POSTSUPERSCRIPT ( 2 / italic_T ) end_POSTSUPERSCRIPT , … , italic_M start_POSTSUPERSCRIPT ( 1 ) end_POSTSUPERSCRIPT is not alignable is strictly bounded away from 0.

Observe that as n𝑛nitalic_n and T𝑇Titalic_T tend to infinity, the relation in Proposition \arabicsection.\arabictheorem simplifies to

γTlog(2)T0.693,𝛾𝑇2𝑇0.693\gamma\geq T\cdot\log(2)\approx T\cdot 0.693,italic_γ ≥ italic_T ⋅ roman_log ( 2 ) ≈ italic_T ⋅ 0.693 ,

and when γ/T=0.693𝛾𝑇0.693\gamma/T=0.693italic_γ / italic_T = 0.693, each node has roughly a 50% probability of switching communities between each consecutive pair of observed networks.

The proof of the lack of alignability first revolves around the observation that if more than n/2𝑛2n/2italic_n / 2 nodes change memberships between consecutive times t𝑡titalic_t and t+1/T𝑡1𝑇t+1/Titalic_t + 1 / italic_T, i.e.,

M(t)M(t+1/T)0>n,subscriptnormsuperscript𝑀𝑡superscript𝑀𝑡1𝑇0𝑛\big{\|}M^{(t)}-M^{(t+1/T)}\big{\|}_{0}>n,∥ italic_M start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT - italic_M start_POSTSUPERSCRIPT ( italic_t + 1 / italic_T ) end_POSTSUPERSCRIPT ∥ start_POSTSUBSCRIPT 0 end_POSTSUBSCRIPT > italic_n , (\arabicequation)

where x0subscriptnorm𝑥0\|x\|_{0}∥ italic_x ∥ start_POSTSUBSCRIPT 0 end_POSTSUBSCRIPT denotes the number of non-zero elements in x𝑥xitalic_x, then, deterministically, the Hungarian assignment between the unobserved membership matrices M(t)superscript𝑀𝑡M^{(t)}italic_M start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT and M(t+1/T)superscript𝑀𝑡1𝑇M^{(t+1/T)}italic_M start_POSTSUPERSCRIPT ( italic_t + 1 / italic_T ) end_POSTSUPERSCRIPT will not be the identity matrix. This means the two membership matrices are not alignable. The proof shows that the event (\arabicequation) occurs with non-vanishing probability.

In contrast, to show that γ/T=o(1)𝛾𝑇𝑜1\gamma/T=o(1)italic_γ / italic_T = italic_o ( 1 ) ensures alignability, our proof strategy is more delicate, as we need to ensure alignability between time t𝑡titalic_t and t+1/T𝑡1𝑇t+1/Titalic_t + 1 / italic_T for each t𝒯\{1}𝑡\𝒯1t\in\mathcal{T}\backslash\{1\}italic_t ∈ caligraphic_T \ { 1 }. First, we discuss a deterministic condition that ensures alignability among all the community structures.

Proposition \arabicsection.\arabictheorem (Deterministic condition for alignability).

Assume any fixed sequence of membership matrices M(1/T),M(2/T),,M(1)superscript𝑀1𝑇superscript𝑀2𝑇normal-…superscript𝑀1M^{(1/T)},M^{(2/T)},\ldots,M^{(1)}italic_M start_POSTSUPERSCRIPT ( 1 / italic_T ) end_POSTSUPERSCRIPT , italic_M start_POSTSUPERSCRIPT ( 2 / italic_T ) end_POSTSUPERSCRIPT , … , italic_M start_POSTSUPERSCRIPT ( 1 ) end_POSTSUPERSCRIPT. For this sequence, if the number of nodes that change memberships between time t𝑡titalic_t and t+1/T𝑡1𝑇t+1/Titalic_t + 1 / italic_T is less than half of the smallest community size at time t𝑡titalic_t for each pair of consecutive time points, meaning

M(t)M(t+1/T)0<mink{1,,K}i=1nMik(t),for some time t𝒯\{1},formulae-sequencesubscriptnormsuperscript𝑀𝑡superscript𝑀𝑡1𝑇0subscript𝑘1𝐾superscriptsubscript𝑖1𝑛subscriptsuperscript𝑀𝑡𝑖𝑘for some time 𝑡\𝒯1\big{\|}M^{(t)}-M^{(t+1/T)}\big{\|}_{0}<\min_{k\in\{1,\ldots,K\}}\sum_{i=1}^{n% }M^{(t)}_{ik},\quad\text{for some time }t\in\mathcal{T}\backslash\{1\},∥ italic_M start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT - italic_M start_POSTSUPERSCRIPT ( italic_t + 1 / italic_T ) end_POSTSUPERSCRIPT ∥ start_POSTSUBSCRIPT 0 end_POSTSUBSCRIPT < roman_min start_POSTSUBSCRIPT italic_k ∈ { 1 , … , italic_K } end_POSTSUBSCRIPT ∑ start_POSTSUBSCRIPT italic_i = 1 end_POSTSUBSCRIPT start_POSTSUPERSCRIPT italic_n end_POSTSUPERSCRIPT italic_M start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT start_POSTSUBSCRIPT italic_i italic_k end_POSTSUBSCRIPT , for some time italic_t ∈ caligraphic_T \ { 1 } ,

then deterministically this sequence of matrices M(1/T),M(2/T),,M(1)superscript𝑀1𝑇superscript𝑀2𝑇normal-…superscript𝑀1M^{(1/T)},M^{(2/T)},\ldots,M^{(1)}italic_M start_POSTSUPERSCRIPT ( 1 / italic_T ) end_POSTSUPERSCRIPT , italic_M start_POSTSUPERSCRIPT ( 2 / italic_T ) end_POSTSUPERSCRIPT , … , italic_M start_POSTSUPERSCRIPT ( 1 ) end_POSTSUPERSCRIPT is alignable.

Proposition \arabicsection.\arabictheorem highlights that alignability is guaranteed if not many nodes change communities relative to the smallest community size. Next, the following proposition ensures that if γ/T=o(1)𝛾𝑇𝑜1\gamma/T=o(1)italic_γ / italic_T = italic_o ( 1 ), this event occurs with high probability, where we focus specifically on a two-community model (i.e., K=2𝐾2K=2italic_K = 2), where each community starts with equal sizes.

Proposition \arabicsection.\arabictheorem (Alignability in a two-community model).

Given Assumptions \arabicsection.\arabicsubsection, \arabicsection.\arabicsubsection, and \arabicsection.\arabictheorem for the model in Section \arabicsection for a two-community model (i.e., K=2𝐾2K=2italic_K = 2) initialized at t=0𝑡0t=0italic_t = 0 to have equal community sizes, if γ/T=o(1)𝛾𝑇𝑜1\gamma/T=o(1)italic_γ / italic_T = italic_o ( 1 ), then with probability at least 12/T12𝑇1-2/T1 - 2 / italic_T, the set of random membership matrices M(1/T),M(2/T),,M(1)superscript𝑀1𝑇superscript𝑀2𝑇normal-…superscript𝑀1M^{(1/T)},M^{(2/T)},\ldots,M^{(1)}italic_M start_POSTSUPERSCRIPT ( 1 / italic_T ) end_POSTSUPERSCRIPT , italic_M start_POSTSUPERSCRIPT ( 2 / italic_T ) end_POSTSUPERSCRIPT , … , italic_M start_POSTSUPERSCRIPT ( 1 ) end_POSTSUPERSCRIPT is alignable.

This proof involves a novel recursive martingale argument since we need to ensure that alignability holds for the entire sequence of membership matrices across each pair of consecutive time points. We expect the argument to work for more general settings under mild conditions with more careful bookkee**.

\arabicsection Numerical experiments

In this section, we describe the tuning procedure to choose r𝑟ritalic_r in a data-adaptive manner since the optimal bandwidth in Corollary \arabicsection.\arabictheorem involves nuisance parameters. Our simulations demonstrate that 1) the tuning procedure reflects the oracle bandwidth, and 2) KD-SoS and the tuning procedure combined outperform other estimators for time-varying SBMs.

\arabicsection.\arabicsubsection Tuning procedure

We design the following procedure to tune the bandwidth r𝑟ritalic_r in practice. Observe that typical tuning procedures for time-varying scalar or matrix-valued data often rely on the observed data’s local smoothness across time. For example, this may be predicting the network A(t)superscript𝐴𝑡A^{(t)}italic_A start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT using all other networks {A(s)}superscript𝐴𝑠\{A^{(s)}\}{ italic_A start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT } for s𝒮(t;r)\{t}𝑠\𝒮𝑡𝑟𝑡s\in\mathcal{S}(t;r)\backslash\{t\}italic_s ∈ caligraphic_S ( italic_t ; italic_r ) \ { italic_t } for 𝒮(t;r)𝒮𝑡𝑟\mathcal{S}(t;r)caligraphic_S ( italic_t ; italic_r ) defined in (\arabicequation), but such a procedure would necessarily require additional smoothness assumptions on the connectivity matrices {B(t)}superscript𝐵𝑡\{B^{(t)}\}{ italic_B start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT } on top of our weaker integrability assumption in Assumption \arabicsection.\arabicsubsection. Since our estimation theory in Theorem \arabicsection.\arabictheorem does not require these additional assumptions, we seek to design a tuning procedure that also does not.

Recall that while Theorem \arabicsection.\arabictheorem does not require smoothness across {B(t)}superscript𝐵𝑡\{B^{(t)}\}{ italic_B start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT }, we assume that the community structure is gradually changing via a Poisson(γ𝛾\gammaitalic_γ) process where γ/T=o(1)𝛾𝑇𝑜1\gamma/T=o(1)italic_γ / italic_T = italic_o ( 1 ) (Assumption \arabicsection.\arabicsubsection). Our theory also demonstrates that changes to the community structure are reflected in the eigenspaces of the probability matrices {P(t)}superscript𝑃𝑡\{P^{(t)}\}{ italic_P start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT }. This inspires our method – for a particular time t𝒯𝑡𝒯t\in\mathcal{T}italic_t ∈ caligraphic_T and choice of bandwidth r𝑟ritalic_r, we kernel-average the networks earlier than t𝑡titalic_t (i.e., {A(s)}superscript𝐴𝑠\{A^{(s)}\}{ italic_A start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT } for s<t𝑠𝑡s<titalic_s < italic_t) and compute its leading eigenspace. We then compute the sinθ𝜃\sin\thetaroman_sin italic_θ distance (defined below) of this eigenspace from the kernel-average the networks later than t𝑡titalic_t (i.e., {A(s)}superscript𝐴𝑠\{A^{(s)}\}{ italic_A start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT } for s>t𝑠𝑡s>titalic_s > italic_t). A small sinΘΘ\sin\Thetaroman_sin roman_Θ distance for an appropriate choice of the bandwidth r^^𝑟\widehat{r}over^ start_ARG italic_r end_ARG would be indicative of two aspects, relative to other choices of r𝑟ritalic_r: 1) the community structure among the networks in 𝒮(t;r^)\[0,t)\𝒮𝑡^𝑟0𝑡\mathcal{S}(t;\widehat{r})\backslash[0,t)caligraphic_S ( italic_t ; over^ start_ARG italic_r end_ARG ) \ [ 0 , italic_t ) are not too dissimilar to those in networks in 𝒮(t;r^)\(t,1]\𝒮𝑡^𝑟𝑡1\mathcal{S}(t;\widehat{r})\backslash(t,1]caligraphic_S ( italic_t ; over^ start_ARG italic_r end_ARG ) \ ( italic_t , 1 ], and 2) r^^𝑟\widehat{r}over^ start_ARG italic_r end_ARG is large enough to produce stably estimated eigenspaces among the networks in 𝒮(t;r^)\[0,t)\𝒮𝑡^𝑟0𝑡\mathcal{S}(t;\widehat{r})\backslash[0,t)caligraphic_S ( italic_t ; over^ start_ARG italic_r end_ARG ) \ [ 0 , italic_t ) or 𝒮(t;r^)\(t,1]\𝒮𝑡^𝑟𝑡1\mathcal{S}(t;\widehat{r})\backslash(t,1]caligraphic_S ( italic_t ; over^ start_ARG italic_r end_ARG ) \ ( italic_t , 1 ]. Reflecting on our bias-variance decomposition in (\arabicequation), the first regards the bias caused by community dynamics, and the second regards the variance due to sparsely observed networks.

Recall that for two orthonormal matrices U,V[1,1]n×K𝑈𝑉superscript11𝑛𝐾U,V\in[-1,1]^{n\times K}italic_U , italic_V ∈ [ - 1 , 1 ] start_POSTSUPERSCRIPT italic_n × italic_K end_POSTSUPERSCRIPT, the sinΘΘ\sin\Thetaroman_sin roman_Θ distance (measured via Frobenius norm) is defined as,

sinΘ(U,V)F=KUVF2.subscriptnormΘ𝑈𝑉𝐹𝐾subscriptsuperscriptnormsuperscript𝑈top𝑉2𝐹\big{\|}\sin\Theta(U,V)\big{\|}_{F}=\sqrt{K-\big{\|}U^{\top}V\big{\|}^{2}_{F}}.∥ roman_sin roman_Θ ( italic_U , italic_V ) ∥ start_POSTSUBSCRIPT italic_F end_POSTSUBSCRIPT = square-root start_ARG italic_K - ∥ italic_U start_POSTSUPERSCRIPT ⊤ end_POSTSUPERSCRIPT italic_V ∥ start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT start_POSTSUBSCRIPT italic_F end_POSTSUBSCRIPT end_ARG . (\arabicequation)

(See references such as Stewart & Sun (1990) and Cai et al. (2018).) Formally, our procedure is as follows. Suppose a grid possible bandwidths r1,,rmsubscript𝑟1subscript𝑟𝑚r_{1},\ldots,r_{m}italic_r start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT , … , italic_r start_POSTSUBSCRIPT italic_m end_POSTSUBSCRIPT are provided, in addition to the observed networks {A(t)}superscript𝐴𝑡\{A^{(t)}\}{ italic_A start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT }.

  1. \arabicenumi.

    For each bandwidth r{r1,,rm}𝑟subscript𝑟1subscript𝑟𝑚r\in\{r_{1},\ldots,r_{m}\}italic_r ∈ { italic_r start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT , … , italic_r start_POSTSUBSCRIPT italic_m end_POSTSUBSCRIPT }, compute the score of the bandwidth θ(r)𝜃𝑟\theta(r)italic_θ ( italic_r ) in the following way.

    1. (a)

      For each time t𝒯𝑡𝒯t\in\mathcal{T}italic_t ∈ caligraphic_T, compute the leading eigenspaces of s𝒮(A(s))2D(s)subscript𝑠𝒮superscriptsuperscript𝐴𝑠2superscript𝐷𝑠\sum_{s\in\mathcal{S}}(A^{(s)})^{2}-D^{(s)}∑ start_POSTSUBSCRIPT italic_s ∈ caligraphic_S end_POSTSUBSCRIPT ( italic_A start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT - italic_D start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT, where 𝒮𝒮\mathcal{S}caligraphic_S is either 𝒮(t;cr)\[0,t)\𝒮𝑡𝑐𝑟0𝑡\mathcal{S}(t;c\cdot r)\backslash[0,t)caligraphic_S ( italic_t ; italic_c ⋅ italic_r ) \ [ 0 , italic_t ) or 𝒮(t;cr)\(t,1]\𝒮𝑡𝑐𝑟𝑡1\mathcal{S}(t;c\cdot r)\backslash(t,1]caligraphic_S ( italic_t ; italic_c ⋅ italic_r ) \ ( italic_t , 1 ] for 𝒮(t;cr)𝒮𝑡𝑐𝑟\mathcal{S}(t;c\cdot r)caligraphic_S ( italic_t ; italic_c ⋅ italic_r ) defined in (\arabicequation). Then, compute the sinΘΘ\sin\Thetaroman_sin roman_Θ distance between these two eigenspaces via (\arabicequation), denoted as θ(t;r)𝜃𝑡𝑟\theta(t;r)italic_θ ( italic_t ; italic_r ).

    2. (b)

      Average θ(t;r)𝜃𝑡𝑟\theta(t;r)italic_θ ( italic_t ; italic_r ) over t𝑡titalic_t. That is, θ(r)=tθ(t;r)/T𝜃𝑟subscript𝑡𝜃𝑡𝑟𝑇\theta(r)=\sum_{t}\theta(t;r)/Titalic_θ ( italic_r ) = ∑ start_POSTSUBSCRIPT italic_t end_POSTSUBSCRIPT italic_θ ( italic_t ; italic_r ) / italic_T.

  2. \arabicenumi.

    Choose the optimal bandwidth with the smallest score, i.e., r^=argminr{r1,,rm}θ(r)^𝑟subscriptargmin𝑟subscript𝑟1subscript𝑟𝑚𝜃𝑟\widehat{r}=\operatorname*{arg\,min}_{r\in\{r_{1},\ldots,r_{m}\}}\theta(r)over^ start_ARG italic_r end_ARG = start_OPERATOR roman_arg roman_min end_OPERATOR start_POSTSUBSCRIPT italic_r ∈ { italic_r start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT , … , italic_r start_POSTSUBSCRIPT italic_m end_POSTSUBSCRIPT } end_POSTSUBSCRIPT italic_θ ( italic_r ).

Observe the presence of a small adjustment factor c>0𝑐0c>0italic_c > 0 when deploying the above tuning strategy. This is to account for the fact the size of the sets 𝒮(t;cr)\[0,t)\𝒮𝑡𝑐𝑟0𝑡\mathcal{S}(t;c\cdot r)\backslash[0,t)caligraphic_S ( italic_t ; italic_c ⋅ italic_r ) \ [ 0 , italic_t ) and 𝒮(t;cr)\(t,1]\𝒮𝑡𝑐𝑟𝑡1\mathcal{S}(t;c\cdot r)\backslash(t,1]caligraphic_S ( italic_t ; italic_c ⋅ italic_r ) \ ( italic_t , 1 ] are both roughly crT𝑐𝑟𝑇c\cdot rTitalic_c ⋅ italic_r italic_T, while the usage of r^^𝑟\widehat{r}over^ start_ARG italic_r end_ARG in KD-SoS would use 𝒮(t;r^)𝒮𝑡^𝑟\mathcal{S}(t;\widehat{r})caligraphic_S ( italic_t ; over^ start_ARG italic_r end_ARG ), a set of size roughly 2r^T+12^𝑟𝑇12\cdot\widehat{r}T+12 ⋅ over^ start_ARG italic_r end_ARG italic_T + 1. Hence, the adjustment factor c𝑐citalic_c scales the bandwidths when tuning to reflect its performance when used by KD-SoS. We have found c=2𝑐2c=2italic_c = 2 to be a reasonable choice in practice.

\arabicsection.\arabicsubsection Simulation

We provide numerical experiments that demonstrate that our estimator described in Section \arabicsection.\arabicsubsection is equipped with a tuning procedure which: 1) selects the bandwidth based on data that mimics the oracle that minimizes the Hamming error, and 2) improves upon other methods designed to estimate the community structure for the model (\arabicequation). We describe our simulation setup. Consider T=50𝑇50T=50italic_T = 50 networks, each consisting of a network among n=500𝑛500n=500italic_n = 500 nodes partitioned into K=3𝐾3K=3italic_K = 3 communities. The first layer set 200 nodes to the first community, 50 nodes to the second community, and 250 nodes to the third community. Then, for each consecutive layer, the nodes switch communities according to the following Markov transition matrix,

[1γ0γ01γγ4γ5γ51γ].matrix1𝛾0𝛾01𝛾𝛾4𝛾5𝛾51𝛾\begin{bmatrix}1-\gamma&0&\gamma\\ 0&1-\gamma&\gamma\\ \frac{4\gamma}{5}&\frac{\gamma}{5}&1-\gamma\end{bmatrix}.[ start_ARG start_ROW start_CELL 1 - italic_γ end_CELL start_CELL 0 end_CELL start_CELL italic_γ end_CELL end_ROW start_ROW start_CELL 0 end_CELL start_CELL 1 - italic_γ end_CELL start_CELL italic_γ end_CELL end_ROW start_ROW start_CELL divide start_ARG 4 italic_γ end_ARG start_ARG 5 end_ARG end_CELL start_CELL divide start_ARG italic_γ end_ARG start_ARG 5 end_ARG end_CELL start_CELL 1 - italic_γ end_CELL end_ROW end_ARG ] . (\arabicequation)

Observe that 100(1γ)1001𝛾100\cdot(1-\gamma)100 ⋅ ( 1 - italic_γ ) percent of the nodes change communities between any two consecutive layers in expectation, and for the given initial community partition, this transition matrix ensures that the community sizes are stationary in expectation. The connectivity matrix is set to alternate between two possible matrices,

B(t)={B(odd)if tTmod2=1,B(even)otherwise for t𝒯,formulae-sequencesuperscript𝐵𝑡casessuperscript𝐵oddmoduloif 𝑡𝑇21superscript𝐵evenotherwise for 𝑡𝒯B^{(t)}=\begin{cases}B^{(\text{odd})}&\quad\text{if }t\cdot T\bmod 2=1,\\ B^{(\text{even})}&\quad\text{otherwise}\end{cases}\quad\text{ for }t\in% \mathcal{T},italic_B start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT = { start_ROW start_CELL italic_B start_POSTSUPERSCRIPT ( odd ) end_POSTSUPERSCRIPT end_CELL start_CELL if italic_t ⋅ italic_T roman_mod 2 = 1 , end_CELL end_ROW start_ROW start_CELL italic_B start_POSTSUPERSCRIPT ( even ) end_POSTSUPERSCRIPT end_CELL start_CELL otherwise end_CELL end_ROW for italic_t ∈ caligraphic_T ,

where

B(odd)=[0.620.220.460.220.620.460.460.460.85],andB(even)=[0.220.620.460.620.220.460.460.460.85].formulae-sequencesuperscript𝐵oddmatrix0.620.220.460.220.620.460.460.460.85andsuperscript𝐵evenmatrix0.220.620.460.620.220.460.460.460.85B^{(\text{odd})}=\begin{bmatrix}0.62&0.22&0.46\\ 0.22&0.62&0.46\\ 0.46&0.46&0.85\end{bmatrix},\quad\text{and}\quad B^{(\text{even})}=\begin{% bmatrix}0.22&0.62&0.46\\ 0.62&0.22&0.46\\ 0.46&0.46&0.85\end{bmatrix}.italic_B start_POSTSUPERSCRIPT ( odd ) end_POSTSUPERSCRIPT = [ start_ARG start_ROW start_CELL 0.62 end_CELL start_CELL 0.22 end_CELL start_CELL 0.46 end_CELL end_ROW start_ROW start_CELL 0.22 end_CELL start_CELL 0.62 end_CELL start_CELL 0.46 end_CELL end_ROW start_ROW start_CELL 0.46 end_CELL start_CELL 0.46 end_CELL start_CELL 0.85 end_CELL end_ROW end_ARG ] , and italic_B start_POSTSUPERSCRIPT ( even ) end_POSTSUPERSCRIPT = [ start_ARG start_ROW start_CELL 0.22 end_CELL start_CELL 0.62 end_CELL start_CELL 0.46 end_CELL end_ROW start_ROW start_CELL 0.62 end_CELL start_CELL 0.22 end_CELL start_CELL 0.46 end_CELL end_ROW start_ROW start_CELL 0.46 end_CELL start_CELL 0.46 end_CELL start_CELL 0.85 end_CELL end_ROW end_ARG ] . (\arabicequation)

Then, the observed data is generated according to the model (\arabicequation), for the desired network density ρnsubscript𝜌𝑛\rho_{n}italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT (varying between sparse networks with ρn=0.05subscript𝜌𝑛0.05\rho_{n}=0.05italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT = 0.05 to dense networks with ρn=1subscript𝜌𝑛1\rho_{n}=1italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT = 1) and the nodes’ community switching transition matrix (\arabicequation) for a given rate γ𝛾\gammaitalic_γ (varying between stable communities with γ=0𝛾0\gamma=0italic_γ = 0 to rapidly-changing communities with γ=0.1𝛾0.1\gamma=0.1italic_γ = 0.1). By considering connectivity matrices B(t)superscript𝐵𝑡B^{(t)}italic_B start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT of the form (\arabicequation), the graphs alternate between being either homophilic or heterophilic.

Refer to caption
Figure \arabicfigure: Simulation across three different settings of the community switching rate γ𝛾\gammaitalic_γ and network density ρnsubscript𝜌𝑛\rho_{n}italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT demonstrating KD-SoS’s performance for different bandwidth r𝑟ritalic_r’s. The Hamming error (\arabicequation) or the bandwidth score measured via sinΘΘ\sin\Thetaroman_sin roman_Θ (\arabicequation) are averaged across 25 trials for each r𝑟ritalic_r (black and blue respectively), and the the vertical dotted lines denote the oracle minimizer of the Hamming error (black) and the chosen bandwidth r^^𝑟\widehat{r}over^ start_ARG italic_r end_ARG using the tuning procedure (blue).

We first show our tuning procedure selects an appropriate bandwidth r𝑟ritalic_r of the box kernel, as demonstrated in Figure \arabicfigure. In the left panel, we fix ρn=0.3subscript𝜌𝑛0.3\rho_{n}=0.3italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT = 0.3 and γ=0.01𝛾0.01\gamma=0.01italic_γ = 0.01 and plot the mean Hamming error across all networks as a function of applying our estimator with the bandwidth r𝑟ritalic_r (black line) and the bandwidth alignment used to tune r𝑟ritalic_r (blue line), both averaged across 25 trials. A dot of their respective color marks the minimum of both curves. We make two observations. First, the Hamming error follows a classical U-shape as a function of r𝑟ritalic_r. This demonstrates that although a single network does not contain information to accurately estimate the communities (i.e., r=0𝑟0r=0italic_r = 0), pooling information across too many networks is not ideal either since the community structures vary too much among the networks (i.e., r=15𝑟15r=15italic_r = 15). Second, while a bandwidth of r=5𝑟5r=5italic_r = 5 achieves the minimum Hamming error, our tuning procedure would select r=6𝑟6r=6italic_r = 6 on average, and the degradation of the Hamming error is not substantial. We also vary ρnsubscript𝜌𝑛\rho_{n}italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT and γ𝛾\gammaitalic_γ. When we set γ𝛾\gammaitalic_γ to be 0.05 instead of 0.10.10.10.1, we see that minimizing bandwidth becomes smaller, reflecting that fewer neighboring networks are relevant for estimating a particular network’s community structure. Alternatively, when we set ρnsubscript𝜌𝑛\rho_{n}italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT to be 0.5 instead of 0.3, we see that minimizing bandwidth becomes smaller. However, as implied by the mean Hamming error on the y-axis, this is because more information is contained within each denser network, lessening the need to pool information across networks.

Refer to caption
Refer to caption
Figure \arabicfigure: Simulation suite across three different settings of the community switching rate γ𝛾\gammaitalic_γ and network density ρnsubscript𝜌𝑛\rho_{n}italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT demonstrating KD-SoS with the bandwidth tuning procedure’s performance (“Kernel,” blue) compared to applying spectral clusterings to only one network at a time (“Singleton,” orange) or aggregating across all networks, akin to Lei & Lin (2022) (“All,” purple).

We now compare our method against other methods designed to estimate communities for the model (\arabicequation). Two natural candidates are our debiasing-and-smoothing method where the bandwidth is set to be r=0𝑟0r=0italic_r = 0 (i.e., “Singleton,” where each network’s community is estimated using only that network) and r=1𝑟1r=1italic_r = 1 (i.e., “All,” where each network’s community is estimated by equally weighting all the networks). We measure the performance of each of the three methods by computing the relative Hamming distance between M^(t)superscript^𝑀𝑡\widehat{M}^{(t)}over^ start_ARG italic_M end_ARG start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT and M(t)superscript𝑀𝑡M^{(t)}italic_M start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT, averaged across all time t𝒯𝑡𝒯t\in\mathcal{T}italic_t ∈ caligraphic_T (i.e., a smaller metric implies better performance). Our results are shown in Figure \arabicfigure. In the first simulation suite, we hold network density ρn=0.5subscript𝜌𝑛0.5\rho_{n}=0.5italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT = 0.5 but vary the community switching rate γ𝛾\gammaitalic_γ from 00 to 0.10.10.10.1 (i.e., stable communities to rapidly changing communities). Across the 50 trials for each value of γ𝛾\gammaitalic_γ, we see that KD-SoS (blue) can retain a small Hamming error below 0.2 across a wide range of γ𝛾\gammaitalic_γ. In contrast, observe that “Singleton” (orange) has a relatively stable performance, which is intuitive as the time-varying structure does not affect this method. Meanwhile, “All” (purple) degrades in performance quite rapidly as γ𝛾\gammaitalic_γ increases due to aggregating among all the networks despite large differences in community structure. In the second simulation suite, we hold community switching rate γ=0.05𝛾0.05\gamma=0.05italic_γ = 0.05 but vary the network density ρnsubscript𝜌𝑛\rho_{n}italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT from 0.20.20.20.2 to 1111 (i.e., sparse networks to dense networks). Across the 50 trials for each value of ρnsubscript𝜌𝑛\rho_{n}italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT, we see that KD-SoS (blue) performs better as ρnsubscript𝜌𝑛\rho_{n}italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT increases, which is uniformly better than the “Singleton” (orange). This is sensible, as KD-SoS aggregates information across networks with an appropriately chosen bandwidth r𝑟ritalic_r. Meanwhile, “All” (purple) does not change in performance as ρnsubscript𝜌𝑛\rho_{n}italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT increases because the time-varying community structure obstructs good performance regardless of network sparsity.

\arabicsection.\arabicsubsection Application to gene co-expression networks along developmental trajectories

We now return to the analysis of the develo** brain introduced in Section \arabicsection. We first enumerate descriptive summary statistics of these twelve networks, each of the same 993 genes. The median of the median degree across all twelve networks is 30.5 (range of 1 to 86, increasing with time), while the mean of the mean degree across all twelve networks is 52.8 (range of 4.6 to 121.9, also increasing with time). The median overall network sparsity, defined as the number of observed edges divided by the number of total possible edges, across all twelve networks is 5% (range of 0.4% to 12%, increasing with time). Lastly, if each network is analyzed separately, the median number of connected components is 97.5 (range of 34 to 452). However, if all the edges across all twelve networks are aggregated, there are two connected components (one with 981 genes, another with 12 genes).

We now describe the results when applying KD-SoS to the dataset. Due to the presence of only twelve networks with very different degrees, we use a Gaussian kernel normalized by each network’s leading singular value, i.e.,

Z(t;r)=s𝒯w(s,t;r)A(s)op[(A(s))2D(s)],where w(s,t;r)=exp((ts)2r2)formulae-sequencesuperscript𝑍𝑡𝑟subscript𝑠𝒯𝑤𝑠𝑡𝑟subscriptnormsuperscript𝐴𝑠opdelimited-[]superscriptsuperscript𝐴𝑠2superscript𝐷𝑠where 𝑤𝑠𝑡𝑟superscript𝑡𝑠2superscript𝑟2Z^{(t;r)}=\sum_{s\in\mathcal{T}}\frac{w(s,t;r)}{\|A^{(s)}\|_{\operatorname{{op% }}}}\cdot\Big{[}(A^{(s)})^{2}-D^{(s)}\Big{]},\quad\text{where }w(s,t;r)=\exp% \Big{(}\frac{-(t-s)^{2}}{r^{2}}\Big{)}italic_Z start_POSTSUPERSCRIPT ( italic_t ; italic_r ) end_POSTSUPERSCRIPT = ∑ start_POSTSUBSCRIPT italic_s ∈ caligraphic_T end_POSTSUBSCRIPT divide start_ARG italic_w ( italic_s , italic_t ; italic_r ) end_ARG start_ARG ∥ italic_A start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT ∥ start_POSTSUBSCRIPT roman_op end_POSTSUBSCRIPT end_ARG ⋅ [ ( italic_A start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT - italic_D start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT ] , where italic_w ( italic_s , italic_t ; italic_r ) = roman_exp ( divide start_ARG - ( italic_t - italic_s ) start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT end_ARG start_ARG italic_r start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT end_ARG )

instead of the aggregation used in (\arabicequation). While our theoretical developments in Theorem \arabicsection.\arabictheorem do not use this estimator, our techniques would apply similarly to such estimators. Based on a scree plot among {A(t)}superscript𝐴𝑡\{A^{(t)}\}{ italic_A start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT }, we chose K=10𝐾10K=10italic_K = 10 as the dimensionality and number of communities. The bandwidth is chosen using our procedure in Section \arabicsection.\arabicsubsection, among the range of bandwidths r𝑟ritalic_r that yielded alignable membership matrices as defined by Definition \arabicsection.\arabictheorem. The membership results for three of the twelve networks are shown in Figure \arabicfigure, where nodes of different colors are in different communities. Already, we can see gradual shifts in communities within these three networks. For example, both the purple and red communities grow in size as time progresses. Meanwhile, genes starting in the olive community eventually become part of the pink or white community.

Refer to caption
Figure \arabicfigure: Three networks, as displayed in Figure \arabicfigure, but with genes colored by the K=10𝐾10K=10italic_K = 10 different communities via K𝐾Kitalic_K different colors as estimated by KD-SoS and the bandwidth tuning procedure.

It is hard to discern the broad summary of how communities are related across time from Figure \arabicfigure. Hence, we plot the percentage of genes that exit from one community to join a different community between the first three networks in Figure \arabicfigure. Our tuning bandwidth procedure chooses an r𝑟ritalic_r that yields relatively stable communities across time. Meanwhile, Figure \arabicfigure also visualizes the latent 10-dimensional embedding among all 993 genes for the first three networks. We observe that: 1) the SBM model is appropriate for modeling the dataset at hand since the heatmaps demonstrate strong block structure, and 2) a choice of K=10𝐾10K=10italic_K = 10 seems visually appropriate, as none of the 10 communities seem to represent sub-communities based on the 10 latent dimensions.

Refer to caption
Figure \arabicfigure: The heatmap of the first three network’s leading K=10𝐾10K=10italic_K = 10 eigenvectors, where the 993 genes are ordered based on their assigned communities, with their colors (left) corresponding to those in Figure \arabicfigure. Let s,t[0,1]𝑠𝑡01s,t\in[0,1]italic_s , italic_t ∈ [ 0 , 1 ] denote two consecutive two times where s<t𝑠𝑡s<titalic_s < italic_t. The size of the arrow connecting two different communities, one at s𝑠sitalic_s and another at t𝑡titalic_t, denotes the percentage of genes that leave the community at time s𝑠sitalic_s to a different community at time t𝑡titalic_t, ranging from 1% of the genes in the community (thin arrow) to 10% (thick arrow).

Now that we have investigated the appropriateness of the time-varying SBM model, we now address the motivating biological questions asked in Section \arabicsection – what new insights about the glutamatergic development that we could investigate based on the dynamic network structure that we couldn’t have inferred based on only analyzing the mean? We focus specifically on the fifth and twelfth networks here. Starting with the fifth network (Figure \arabicfigureA), we show the enriched gene ontology (GO) terms for the selected communities in Table \arabicsection.\arabicsubsection to inquire about the functionality of each set of genes. For example, community 2 (red) is highly enriched for coordinated genes related to neurogenesis despite these genes not yet having high mean expression. In contrast, community 6 (olive) contains genes related to nervous system development with high gene expression but are not as coordinated. Meanwhile, community 8 (blue) is highly enriched for coordinated and highly expressed genes related to cellular component biogenesis. Likewise, in the twelfth network (Figure \arabicfigureA and Table \arabicsection.\arabicsubsection), community 1 (burgundy) is highly enriched for coordinated genes related to cell cycle, despite these genes not yet having high mean expression. In contrast, community 2 (red) is still highly enriched for genes related to neurogenesis (the same as the fifth network), but now these genes are highly expressed but not coordinated. Lastly, community 7 (purple) is highly enriched for coordinated and highly expressed genes related to the metabolic process. Altogether, these results demonstrate that investigating the dynamics of gene coordination can give an alternative perspective on brain development.

Refer to caption
Figure \arabicfigure: Correlation networks for the second (A) or twelfth (B) timepoints, where the cells corresponding to the respective bin of pseudotimes are highlighted via the cell-gene heatmap (left) and the corresponding adjacency matrix among 993 genes where the genes are organized based on their estimated memberships for the respective timepoint (right). The cell-gene heatmaps are the same as in Figure \arabicfigure. Below the heatmaps marks the genes (i.e., columns) that are part of specifically highlighted communities, corresponding to the marked entries of the adjacency matrices.
\tbl

Description of select gene communities for network t=5/12𝑡512t=5/12italic_t = 5 / 12 Summary stat. Gene set enrichment # genes Mean value (std.) Connectivity GO term % of community FDR p-value Community 2 (Red) 76 0.06 (0.08) 0.72 GO:0022008 (Neurogenesis) 29% 2.91×1062.91superscript1062.91\times 10^{-6}2.91 × 10 start_POSTSUPERSCRIPT - 6 end_POSTSUPERSCRIPT Community 6 (Olive) 65 0.51 (0.36) 0.23 GO:0007399 (Nervous system development) 32% 7.66×1037.66superscript1037.66\times 10^{-3}7.66 × 10 start_POSTSUPERSCRIPT - 3 end_POSTSUPERSCRIPT Community 8 (Blue) 74 0.54 (0.27) 0.88 GO:0044085 (Cellular component biogenesis) 36% 2.74×1042.74superscript1042.74\times 10^{-4}2.74 × 10 start_POSTSUPERSCRIPT - 4 end_POSTSUPERSCRIPT {tabnote} Select gene communities for network t=5/12𝑡512t=5/12italic_t = 5 / 12, depicting (from left to right) the number of genes in the community, the mean gene expression value and standard deviation among all the cells in this partition (after each gene is standardized across all 18,160 cells), the percent of edges among the genes in the community, an enriched GO term among these genes, the percentage of genes in this community that are in this GO term, and the GO term’s FDR value.

\tbl

Description of select gene communities for network t=12/12𝑡1212t=12/12italic_t = 12 / 12 Summary stat. Gene set enrichment # genes Mean value (std.) Connectivity GO term % of community FDR p-value Community 1 (burgundy) 57 0.01 (0.03) 0.66 GO:0007049 (Cell cycle) 68% 4.42×10324.42superscript10324.42\times 10^{-32}4.42 × 10 start_POSTSUPERSCRIPT - 32 end_POSTSUPERSCRIPT Community 2 (Red) 71 0.52 (0.32) 0.13 GO:0022008 (Neurogenesis) 24% 1.43×1031.43superscript1031.43\times 10^{-3}1.43 × 10 start_POSTSUPERSCRIPT - 3 end_POSTSUPERSCRIPT Community 7 (Purple) 89 0.43 (0.35) 0.77 GO: 0008152 (Metabolic process) 63% 9.57×1039.57superscript1039.57\times 10^{-3}9.57 × 10 start_POSTSUPERSCRIPT - 3 end_POSTSUPERSCRIPT {tabnote} Select gene communities for network t=12/12𝑡1212t=12/12italic_t = 12 / 12, displayed in the same layout as Table 1.

Additional plots corresponding to networks not shown in Figures \arabicfigure through \arabicfigure as well as additional visualizations of the time-varying dynamics are included in the Appendix.

\arabicsection Discussion

We establish a bridge between time-varying network analysis and non-parametric analysis in this paper, demonstrating that smoothness across the connectivity matrices {B(t)}superscript𝐵𝑡\{B^{(t)}\}{ italic_B start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT } is not required for consistent community detection. We achieve this through a novel bias-variance decomposition, whereby we project networks close to time t𝑡titalic_t onto the leading eigenspace of the network at time t𝑡titalic_t. While our paper has demonstrated how to relate the discrete changes in nodes’ communities to the typically continuous non-parametric theory, there are two major theoretical directions we hope our work can aid for future research. The first is refining this relation between time-varying networks and non-parametric analyses. While previous work for time-varying networks such as Pensky & Zhang (2019) and Keriven & Vaiter (2022) derived rates reliant on the smoothness across {B(t)}superscript𝐵𝑡\{B^{(t)}\}{ italic_B start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT }, it is unclear from a minimax perspective how the community estimation rates improve as {B(t)}superscript𝐵𝑡\{B^{(t)}\}{ italic_B start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT } evolve according to a smoother process. Additionally, there have been major historical developments in non-parametric analysis through local polynomials and trend filtering. These address the so-called boundary bias typical in non-parametric regression and construct estimators that inherently adapt to the data’s smoothness. We wonder if there are analogies for these estimators for the time-varying SBM setting. Secondly, as with any non-parametric estimator, there are unanswered questions about how to best tune estimators such as KD-SoS. As we described in Section \arabicsection.\arabicsubsection, tuning procedures reliant on prediction, such as cross-validation, are unlikely to be fruitful for the setting we study. However, recent ideas using leave-one-out analysis or sharp 2subscript2\ell_{2\rightarrow\infty}roman_ℓ start_POSTSUBSCRIPT 2 → ∞ end_POSTSUBSCRIPT estimation bounds for the leading eigenspaces have successfully derived cross-validation-like approaches in other network settings. We believe those ideas can be used similarly in our setting where {B(t)}superscript𝐵𝑡\{B^{(t)}\}{ italic_B start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT } is not assumed to be positive definite or smoothly varying.

References

  • Abbe (2017) Abbe, E. (2017). Community detection and stochastic block models: Recent developments. The Journal of Machine Learning Research 18, 6446–6531.
  • Arroyo et al. (2021) Arroyo, J., Athreya, A., Cape, J., Chen, G., Priebe, C. E. & Vogelstein, J. T. (2021). Inference for multiple heterogeneous networks with a common invariant subspace. Journal of Machine Learning Research 22, 1–49.
  • Athreya et al. (2022) Athreya, A., Lubberts, Z., Park, Y. & Priebe, C. E. (2022). Discovering underlying dynamics in time series of networks. arXiv preprint arXiv:2205.06877 .
  • Bhattacharyya & Chatterjee (2020) Bhattacharyya, S. & Chatterjee, S. (2020). General community detection with optimal recovery conditions for multi-relational sparse networks with dependent layers. arXiv preprint arXiv:2004.03480 .
  • Bickel & Chen (2009) Bickel, P. J. & Chen, A. (2009). A nonparametric view of network models and newman–girvan and other modularities. Proceedings of the National Academy of Sciences 106, 21068–21073.
  • Cai et al. (2018) Cai, T. T., Zhang, A. et al. (2018). Rate-optimal perturbation bounds for singular subspaces with applications to high-dimensional statistics. The Annals of Statistics 46, 60–89.
  • Chen et al. (2020) Chen, S., Liu, S. & Ma, Z. (2020). Global and individualized community detection in inhomogeneous multilayer networks. arXiv preprint arXiv:2012.00933 .
  • De la Pena & Giné (2012) De la Pena, V. & Giné, E. (2012). Decoupling: from dependence to independence. Springer Science & Business Media.
  • Gallagher et al. (2021) Gallagher, I., Jones, A. & Rubin-Delanchy, P. (2021). Spectral embedding for dynamic networks with stability guarantees. arXiv preprint arXiv:2106.01282 .
  • Han et al. (2015) Han, Q., Xu, K. & Airoldi, E. (2015). Consistent estimation of dynamic and multi-layer block models. In International Conference on Machine Learning. PMLR.
  • Holland et al. (1983) Holland, P. W., Laskey, K. B. & Leinhardt, S. (1983). Stochastic blockmodels: First steps. Social networks 5, 109–137.
  • Huang et al. (2018) Huang, M., Wang, J., Torre, E., Dueck, H., Shaffer, S., Bonasio, R., Murray, J. I., Raj, A., Li, M. & Zhang, N. R. (2018). SAVER: Gene expression recovery for single-cell RNA sequencing. Nature Methods 15, 539–542.
  • Keriven & Vaiter (2022) Keriven, N. & Vaiter, S. (2022). Sparse and smooth: Improved guarantees for spectral clustering in the dynamic stochastic block model. Electronic Journal of Statistics 16, 1330–1366.
  • Kim et al. (2018) Kim, B., Lee, K. H., Xue, L. & Niu, X. (2018). A review of dynamic network models with latent variables. Statistics surveys 12, 105.
  • Lei et al. (2020) Lei, J., Chen, K. & Lynch, B. (2020). Consistent community detection in multi-layer network data. Biometrika 107, 61–73.
  • Lei & Lin (2022) Lei, J. & Lin, K. Z. (2022). Bias-adjusted spectral clustering in multi-layer stochastic block models. Journal of the American Statistical Association , 1–13.
  • Lei & Rinaldo (2015) Lei, J. & Rinaldo, A. (2015). Consistency of spectral clustering in stochastic block models. The Annals of Statistics 43, 215–237.
  • Lei et al. (2023) Lei, J., Zhang, A. R. & Zhu, Z. (2023). Computational and statistical thresholds in multi-layer stochastic block models. arXiv preprint arXiv:2311.07773 .
  • Liu et al. (2018) Liu, F., Choi, D., Xie, L. & Roeder, K. (2018). Global spectral clustering in dynamic networks. Proceedings of the National Academy of Sciences 115, 927–932.
  • McInnes et al. (2018) McInnes, L., Healy, J. & Melville, J. (2018). UMAP: Uniform manifold approximation and projection for dimension reduction. arXiv preprint arXiv:1802.03426 .
  • Paul & Chen (2020) Paul, S. & Chen, Y. (2020). Spectral and matrix factorization methods for consistent community detection in multi-layer networks. The Annals of Statistics 48, 230–250.
  • Pelekis (2016) Pelekis, C. (2016). Lower bounds on binomial and poisson tails: an approach via tail conditional expectations. arXiv preprint arXiv:1609.06651 .
  • Pensky & Zhang (2019) Pensky, M. & Zhang, T. (2019). Spectral clustering in the dynamic stochastic block model. Electronic Journal of Statistics 13, 678–709.
  • Sarkar & Moore (2006) Sarkar, P. & Moore, A. W. (2006). Dynamic social network analysis using latent space models. Advances in neural information processing systems 18, 1145.
  • Stewart & Sun (1990) Stewart, G. & Sun, J. (1990). Matrix perturbation theory, acad. Press, Boston MA .
  • Street et al. (2018) Street, K., Risso, D., Fletcher, R. B., Das, D., Ngai, J., Yosef, N., Purdom, E. & Dudoit, S. (2018). Slingshot: Cell lineage and pseudotime inference for single-cell transcriptomics. BMC Genomics 19, 477.
  • Trevino et al. (2021) Trevino, A. E., Müller, F., Andersen, J., Sundaram, L., Kathiria, A., Shcherbina, A., Farh, K., Chang, H. Y., Pașca, A. M., Kundaje, A., Pasca, S. P. & Greenleaf, W. J. (2021). Chromatin and gene-regulatory dynamics of the develo** human cerebral cortex at single-cell resolution. Cell .
  • Wang et al. (2021) Wang, D., Yu, Y. & Rinaldo, A. (2021). Optimal change point detection and localization in sparse dynamic networks. The Annals of Statistics 49, 203–232.
  • Yang & Peng (2020) Yang, J. & Peng, J. (2020). Estimating time-varying graphical models. Journal of Computational and Graphical Statistics 29, 191–202.
  • Yu et al. (2014) Yu, Y., Wang, T. & Samworth, R. J. (2014). A useful variant of the Davis–Kahan theorem for statisticians. Biometrika 102, 315–323.

Acknowledgement

We thank David Choi, Bernie Devlin, and Kathryn Roeder for useful comments when develo** this method. **g Lei’s research is partially supported by NSF grants DMS-2015492 and DMS-2310764.

Data and code reproducibility

The human brain development dataset (Trevino et al., 2021) was downloaded from https://www.ncbi.nlm.nih.gov/geo/query/acc.cgi?acc=GSE162170, specifically the GSE162170_rna_counts.tsv.gz and GSE162170_rna_cell_metadata.txt files. (Alternatively, the data can also be accessed via https://github.com/GreenleafLab/brainchromatin.) We use the author’s clustering information derived from the Supplementary Information of Trevino et al. (2021), Table S1 (file: 1-s2.0-S0092867421009429-mmc1.xlsx, Sheet F), and genes from Table S1 and Table S3 (files: 1-s2.0-S0092867421009429-mmc1.xlsx, Sheet G and 1-s2.0-S0092867421009429-mmc3.xlsx, Sheet A). The code for the KD-SoS as well as all simulations and analyses (including the details on how we preprocessed the single-cell RNA-seq data) is in https://github.com/linnykos/dynamicGraphRoot.

Supplementary material

In the supplementary materials, we include the proofs of Lemma \arabicsection.\arabictheorem, Theorem \arabicsection.\arabictheorem, Corollary \arabicsection.\arabictheorem, Corollary \arabicsection.\arabictheorem, Corollary \arabicsection.\arabictheorem, Proposition \arabicsection.\arabictheorem, Proposition \arabicsection.\arabictheorem, and Proposition \arabicsection.\arabictheorem. We also include preprocessing details and more supplemental results in the scRNA-seq analysis from Section \arabicsection.\arabicsubsection.

\appendixone

Proofs

Proof for bias-variance tradeoff

Proof .\arabictheorem.

The proof is straightforward after observing for any t𝒯𝑡𝒯t\in\mathcal{T}italic_t ∈ caligraphic_T,

(A(t))2=(P(t)+X(t))2=(P(t))2+P(t)X(t)+X(t)P(t)+(X(t))2.superscriptsuperscript𝐴𝑡2superscriptsuperscript𝑃𝑡superscript𝑋𝑡2superscriptsuperscript𝑃𝑡2superscript𝑃𝑡superscript𝑋𝑡superscript𝑋𝑡superscript𝑃𝑡superscriptsuperscript𝑋𝑡2(A^{(t)})^{2}=(P^{(t)}+X^{(t)})^{2}=(P^{(t)})^{2}+P^{(t)}X^{(t)}+X^{(t)}P^{(t)% }+(X^{(t)})^{2}.( italic_A start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT = ( italic_P start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT + italic_X start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT = ( italic_P start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT + italic_P start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT italic_X start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT + italic_X start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT italic_P start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT + ( italic_X start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT .

and furthermore,

(P(t))2=(Q(t))2+[diag(Q(t))]2Q(t)diag(Q(t))diag(Q(t))Q(t).superscriptsuperscript𝑃𝑡2superscriptsuperscript𝑄𝑡2superscriptdelimited-[]diagsuperscript𝑄𝑡2superscript𝑄𝑡diagsuperscript𝑄𝑡diagsuperscript𝑄𝑡superscript𝑄𝑡(P^{(t)})^{2}=(Q^{(t)})^{2}+\big{[}\operatorname{{diag}}(Q^{(t)})\big{]}^{2}-Q% ^{(t)}\operatorname{{diag}}(Q^{(t)})-\operatorname{{diag}}(Q^{(t)})Q^{(t)}.( italic_P start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT = ( italic_Q start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT + [ roman_diag ( italic_Q start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ) ] start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT - italic_Q start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT roman_diag ( italic_Q start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ) - roman_diag ( italic_Q start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ) italic_Q start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT .

Proof of Theorem \arabicsection.\arabictheorem.

Proof .\arabictheorem.

Let c𝑐citalic_c be a constant that can vary from term to term, depending only on the constants c1subscript𝑐1c_{1}italic_c start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT, c2subscript𝑐2c_{2}italic_c start_POSTSUBSCRIPT 2 end_POSTSUBSCRIPT, c3subscript𝑐3c_{3}italic_c start_POSTSUBSCRIPT 3 end_POSTSUBSCRIPT, cδsubscript𝑐𝛿c_{\delta}italic_c start_POSTSUBSCRIPT italic_δ end_POSTSUBSCRIPT, and K𝐾Kitalic_K. Consider the decomposition in Lemma \arabicsection.\arabictheorem, where we focus on the time t𝒯𝑡𝒯t\in\mathcal{T}italic_t ∈ caligraphic_T. We start with the membership bias term (i.e., term I𝐼Iitalic_I). Let op\|\cdot\|_{\operatorname{{op}}}∥ ⋅ ∥ start_POSTSUBSCRIPT roman_op end_POSTSUBSCRIPT denote the operator norm (i.e., largest singular value). For h=c(γr+log(n)/n)normal-⋅𝑐𝛾𝑟𝑛𝑛h=c\cdot(\gamma r+\log(n)/n)italic_h = italic_c ⋅ ( italic_γ italic_r + roman_log ( italic_n ) / italic_n ) for a bandwidth of length r𝑟ritalic_r, consider the event that

\displaystyle\mathcal{E}caligraphic_E ={maxs𝒮(t;r)L(M(s),M(t))h}1{nk(t)[1cKn,cKn],for all k{1,,K},t𝒯}2.absentsubscriptsubscript𝑠𝒮𝑡𝑟𝐿superscript𝑀𝑠superscript𝑀𝑡subscript1subscriptformulae-sequencesuperscriptsubscript𝑛𝑘𝑡1𝑐𝐾𝑛𝑐𝐾𝑛formulae-sequencefor all 𝑘1𝐾𝑡𝒯subscript2\displaystyle=\underbrace{\Big{\{}\max_{s\in\mathcal{S}(t;r)}L\big{(}M^{(s)},M% ^{(t)}\big{)}\leq h\Big{\}}}_{\mathcal{E}_{1}}\bigcap\underbrace{\Big{\{}n_{k}% ^{(t)}\in\Big{[}\frac{1}{cK}\cdot n,\frac{c}{K}\cdot n\Big{]},\quad\text{for % all }k\in\{1,\ldots,K\},\;t\in\mathcal{T}\Big{\}}}_{\mathcal{E}_{2}}.= under⏟ start_ARG { roman_max start_POSTSUBSCRIPT italic_s ∈ caligraphic_S ( italic_t ; italic_r ) end_POSTSUBSCRIPT italic_L ( italic_M start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT , italic_M start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ) ≤ italic_h } end_ARG start_POSTSUBSCRIPT caligraphic_E start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT end_POSTSUBSCRIPT ⋂ under⏟ start_ARG { italic_n start_POSTSUBSCRIPT italic_k end_POSTSUBSCRIPT start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ∈ [ divide start_ARG 1 end_ARG start_ARG italic_c italic_K end_ARG ⋅ italic_n , divide start_ARG italic_c end_ARG start_ARG italic_K end_ARG ⋅ italic_n ] , for all italic_k ∈ { 1 , … , italic_K } , italic_t ∈ caligraphic_T } end_ARG start_POSTSUBSCRIPT caligraphic_E start_POSTSUBSCRIPT 2 end_POSTSUBSCRIPT end_POSTSUBSCRIPT . (\arabicequation)

Lemma .\arabictheorem shows that the event 1subscript1\mathcal{E}_{1}caligraphic_E start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT happens with probability at least 11/n11𝑛1-1/n1 - 1 / italic_n, and the event 2subscript2\mathcal{E}_{2}caligraphic_E start_POSTSUBSCRIPT 2 end_POSTSUBSCRIPT is controlled by Assumption \arabicsection.\arabicsubsection. Hence, by union bound, this means event \mathcal{E}caligraphic_E happens with probability at least 11/nϵc2,n11𝑛subscriptitalic-ϵsubscript𝑐2𝑛1-1/n-\epsilon_{c_{2},n}1 - 1 / italic_n - italic_ϵ start_POSTSUBSCRIPT italic_c start_POSTSUBSCRIPT 2 end_POSTSUBSCRIPT , italic_n end_POSTSUBSCRIPT.

The remainder of our analysis will be done in the intersection with event \mathcal{E}caligraphic_E. We start by analyzing the minimum eigenvalue of the target term (i.e., term V𝑉Vitalic_V in (\arabicequation)). We define M~(t)=M(t)(Δ(t))1/2superscriptnormal-~𝑀𝑡superscript𝑀𝑡superscriptsuperscriptnormal-Δ𝑡12\widetilde{M}^{(t)}=M^{(t)}\big{(}\Delta^{(t)}\big{)}^{-1/2}over~ start_ARG italic_M end_ARG start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT = italic_M start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ( roman_Δ start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT - 1 / 2 end_POSTSUPERSCRIPT as well as

B~(t)=(Δ(t))1/2B(t)(Δ(t))1/2,superscript~𝐵𝑡superscriptsuperscriptΔ𝑡12superscript𝐵𝑡superscriptsuperscriptΔ𝑡12\widetilde{B}^{(t)}=\big{(}\Delta^{(t)}\big{)}^{1/2}B^{(t)}\big{(}\Delta^{(t)}% \big{)}^{1/2},over~ start_ARG italic_B end_ARG start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT = ( roman_Δ start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT italic_B start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ( roman_Δ start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT , (\arabicequation)

so that Q(t)=ρnM(t)B(t)(M(t))=ρnM~(t)B~(t)(M~(t))superscript𝑄𝑡normal-⋅subscript𝜌𝑛superscript𝑀𝑡superscript𝐵𝑡superscriptsuperscript𝑀𝑡topnormal-⋅subscript𝜌𝑛superscriptnormal-~𝑀𝑡superscriptnormal-~𝐵𝑡superscriptsuperscriptnormal-~𝑀𝑡topQ^{(t)}=\rho_{n}\cdot M^{(t)}B^{(t)}(M^{(t)})^{\top}=\rho_{n}\cdot\widetilde{M% }^{(t)}\widetilde{B}^{(t)}(\widetilde{M}^{(t)})^{\top}italic_Q start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT = italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT ⋅ italic_M start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT italic_B start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ( italic_M start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT ⊤ end_POSTSUPERSCRIPT = italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT ⋅ over~ start_ARG italic_M end_ARG start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT over~ start_ARG italic_B end_ARG start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ( over~ start_ARG italic_M end_ARG start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT ⊤ end_POSTSUPERSCRIPT. Also recall that the definition of the projection matrix Π(t)=M~(t)(M~)superscriptnormal-Π𝑡superscriptnormal-~𝑀𝑡superscriptnormal-~𝑀top\Pi^{(t)}=\widetilde{M}^{(t)}(\widetilde{M})^{\top}roman_Π start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT = over~ start_ARG italic_M end_ARG start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ( over~ start_ARG italic_M end_ARG ) start_POSTSUPERSCRIPT ⊤ end_POSTSUPERSCRIPT. We start with the observation that

s𝒮(t;r)Π(t)(Q(s))2Π(t)op=s𝒮(t;r)M~(t)(M~(t))(Q(s))2M~(t)(M~(t))opsubscriptnormsubscript𝑠𝒮𝑡𝑟superscriptΠ𝑡superscriptsuperscript𝑄𝑠2superscriptΠ𝑡opsubscriptnormsubscript𝑠𝒮𝑡𝑟superscript~𝑀𝑡superscriptsuperscript~𝑀𝑡topsuperscriptsuperscript𝑄𝑠2superscript~𝑀𝑡superscriptsuperscript~𝑀𝑡topop\displaystyle\Big{\|}\sum_{s\in\mathcal{S}(t;r)}\Pi^{(t)}(Q^{(s)})^{2}\Pi^{(t)% }\Big{\|}_{\operatorname{{op}}}=\Big{\|}\sum_{s\in\mathcal{S}(t;r)}\widetilde{% M}^{(t)}(\widetilde{M}^{(t)})^{\top}(Q^{(s)})^{2}\widetilde{M}^{(t)}(% \widetilde{M}^{(t)})^{\top}\Big{\|}_{\operatorname{{op}}}∥ ∑ start_POSTSUBSCRIPT italic_s ∈ caligraphic_S ( italic_t ; italic_r ) end_POSTSUBSCRIPT roman_Π start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ( italic_Q start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT roman_Π start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ∥ start_POSTSUBSCRIPT roman_op end_POSTSUBSCRIPT = ∥ ∑ start_POSTSUBSCRIPT italic_s ∈ caligraphic_S ( italic_t ; italic_r ) end_POSTSUBSCRIPT over~ start_ARG italic_M end_ARG start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ( over~ start_ARG italic_M end_ARG start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT ⊤ end_POSTSUPERSCRIPT ( italic_Q start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT over~ start_ARG italic_M end_ARG start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ( over~ start_ARG italic_M end_ARG start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT ⊤ end_POSTSUPERSCRIPT ∥ start_POSTSUBSCRIPT roman_op end_POSTSUBSCRIPT
=ρn2s𝒮(t;r)(M~(t))M~(s)=U(t;s)(B~(s))2(M~(s))M~(t)opabsentsuperscriptsubscript𝜌𝑛2subscriptnormsubscript𝑠𝒮𝑡𝑟subscriptsuperscriptsuperscript~𝑀𝑡topsuperscript~𝑀𝑠absentsuperscript𝑈𝑡𝑠superscriptsuperscript~𝐵𝑠2superscriptsuperscript~𝑀𝑠topsuperscript~𝑀𝑡op\displaystyle=\rho_{n}^{2}\cdot\Big{\|}\sum_{s\in\mathcal{S}(t;r)}\underbrace{% (\widetilde{M}^{(t)})^{\top}\widetilde{M}^{(s)}}_{=U^{(t;s)}}(\widetilde{B}^{(% s)})^{2}(\widetilde{M}^{(s)})^{\top}\widetilde{M}^{(t)}\Big{\|}_{\operatorname% {{op}}}= italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT ⋅ ∥ ∑ start_POSTSUBSCRIPT italic_s ∈ caligraphic_S ( italic_t ; italic_r ) end_POSTSUBSCRIPT under⏟ start_ARG ( over~ start_ARG italic_M end_ARG start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT ⊤ end_POSTSUPERSCRIPT over~ start_ARG italic_M end_ARG start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT end_ARG start_POSTSUBSCRIPT = italic_U start_POSTSUPERSCRIPT ( italic_t ; italic_s ) end_POSTSUPERSCRIPT end_POSTSUBSCRIPT ( over~ start_ARG italic_B end_ARG start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT ( over~ start_ARG italic_M end_ARG start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT ⊤ end_POSTSUPERSCRIPT over~ start_ARG italic_M end_ARG start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ∥ start_POSTSUBSCRIPT roman_op end_POSTSUBSCRIPT
(i)ρn2s𝒮(t;r)σmin2(U(t;s))(B~(s))2opρn2[mins𝒮(t;r){σmin2(U(t;s))}]s𝒮(t;r)(B~(s))2op𝑖superscriptsubscript𝜌𝑛2subscriptnormsubscript𝑠𝒮𝑡𝑟superscriptsubscript𝜎2superscript𝑈𝑡𝑠superscriptsuperscript~𝐵𝑠2opsuperscriptsubscript𝜌𝑛2subscriptnormdelimited-[]subscript𝑠𝒮𝑡𝑟subscriptsuperscript𝜎2superscript𝑈𝑡𝑠subscript𝑠𝒮𝑡𝑟superscriptsuperscript~𝐵𝑠2op\displaystyle\overset{(i)}{\geq}\rho_{n}^{2}\cdot\Big{\|}\sum_{s\in\mathcal{S}% (t;r)}\sigma_{\min}^{2}(U^{(t;s)})\cdot(\widetilde{B}^{(s)})^{2}\Big{\|}_{% \operatorname{{op}}}\geq\rho_{n}^{2}\cdot\Big{\|}\Big{[}\min_{s\in\mathcal{S}(% t;r)}\Big{\{}\sigma^{2}_{\min}\big{(}U^{(t;s)}\big{)}\Big{\}}\Big{]}\sum_{s\in% \mathcal{S}(t;r)}(\widetilde{B}^{(s)})^{2}\Big{\|}_{\operatorname{{op}}}start_OVERACCENT ( italic_i ) end_OVERACCENT start_ARG ≥ end_ARG italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT ⋅ ∥ ∑ start_POSTSUBSCRIPT italic_s ∈ caligraphic_S ( italic_t ; italic_r ) end_POSTSUBSCRIPT italic_σ start_POSTSUBSCRIPT roman_min end_POSTSUBSCRIPT start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT ( italic_U start_POSTSUPERSCRIPT ( italic_t ; italic_s ) end_POSTSUPERSCRIPT ) ⋅ ( over~ start_ARG italic_B end_ARG start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT ∥ start_POSTSUBSCRIPT roman_op end_POSTSUBSCRIPT ≥ italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT ⋅ ∥ [ roman_min start_POSTSUBSCRIPT italic_s ∈ caligraphic_S ( italic_t ; italic_r ) end_POSTSUBSCRIPT { italic_σ start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT start_POSTSUBSCRIPT roman_min end_POSTSUBSCRIPT ( italic_U start_POSTSUPERSCRIPT ( italic_t ; italic_s ) end_POSTSUPERSCRIPT ) } ] ∑ start_POSTSUBSCRIPT italic_s ∈ caligraphic_S ( italic_t ; italic_r ) end_POSTSUBSCRIPT ( over~ start_ARG italic_B end_ARG start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT ∥ start_POSTSUBSCRIPT roman_op end_POSTSUBSCRIPT
(ii)(1ch1/2)ρn2s𝒮(t;r)(B~(s))2op(iii)c(1ch1/2)T~ρn2n2,𝑖𝑖1𝑐superscript12superscriptsubscript𝜌𝑛2subscriptnormsubscript𝑠𝒮𝑡𝑟superscriptsuperscript~𝐵𝑠2op𝑖𝑖𝑖𝑐1𝑐superscript12~𝑇superscriptsubscript𝜌𝑛2superscript𝑛2\displaystyle\overset{(ii)}{\geq}(1-ch^{1/2})\cdot\rho_{n}^{2}\cdot\Big{\|}% \sum_{s\in\mathcal{S}(t;r)}(\widetilde{B}^{(s)})^{2}\Big{\|}_{\operatorname{{% op}}}\overset{(iii)}{\geq}c\cdot(1-ch^{1/2})\cdot\widetilde{T}\rho_{n}^{2}n^{2},start_OVERACCENT ( italic_i italic_i ) end_OVERACCENT start_ARG ≥ end_ARG ( 1 - italic_c italic_h start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT ) ⋅ italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT ⋅ ∥ ∑ start_POSTSUBSCRIPT italic_s ∈ caligraphic_S ( italic_t ; italic_r ) end_POSTSUBSCRIPT ( over~ start_ARG italic_B end_ARG start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT ∥ start_POSTSUBSCRIPT roman_op end_POSTSUBSCRIPT start_OVERACCENT ( italic_i italic_i italic_i ) end_OVERACCENT start_ARG ≥ end_ARG italic_c ⋅ ( 1 - italic_c italic_h start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT ) ⋅ over~ start_ARG italic_T end_ARG italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT italic_n start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT , (\arabicequation)

where T~=|𝒮(t;r)|=min{2rT+1,T}normal-~𝑇𝒮𝑡𝑟2𝑟𝑇1𝑇\widetilde{T}=|\mathcal{S}(t;r)|=\min\{2rT+1,T\}over~ start_ARG italic_T end_ARG = | caligraphic_S ( italic_t ; italic_r ) | = roman_min { 2 italic_r italic_T + 1 , italic_T } denotes the number of networks with non-zero weights via the box kernel of bandwidth r𝑟ritalic_r. Here, (i)𝑖(i)( italic_i ) holds by the variational characterization of eigenvalues (i.e., Rayleigh-Ritz theorem), (ii)𝑖𝑖(ii)( italic_i italic_i ) holds using Lemma .\arabictheorem, the definition of hhitalic_h under the event \mathcal{E}caligraphic_E in (\arabicequation), as well as (1x)2=12x+x212xsuperscript1𝑥212𝑥superscript𝑥212𝑥(1-x)^{2}=1-2x+x^{2}\geq 1-2x( 1 - italic_x ) start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT = 1 - 2 italic_x + italic_x start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT ≥ 1 - 2 italic_x for x<1𝑥1x<1italic_x < 1, and (iii)𝑖𝑖𝑖(iii)( italic_i italic_i italic_i ) holds via Assumptions \arabicsection.\arabicsubsection and \arabicsection.\arabicsubsection and the definition of B~normal-~𝐵\widetilde{B}over~ start_ARG italic_B end_ARG in (\arabicequation).

We now move to upper-bound relevant terms in (\arabicequation). Recall that σmin(A)subscript𝜎𝐴\sigma_{\min}(A)italic_σ start_POSTSUBSCRIPT roman_min end_POSTSUBSCRIPT ( italic_A ) denote the smallest singular value of a matrix A𝐴Aitalic_A. For term I𝐼Iitalic_I, observe that

(Q(s))2Π(t)(Q(s))2Π(t)op=Π(s)(Q(s))2Π(s)Π(t)(Q(s))2Π(t)opsubscriptnormsuperscriptsuperscript𝑄𝑠2superscriptΠ𝑡superscriptsuperscript𝑄𝑠2superscriptΠ𝑡opsubscriptnormsuperscriptΠ𝑠superscriptsuperscript𝑄𝑠2superscriptΠ𝑠superscriptΠ𝑡superscriptsuperscript𝑄𝑠2superscriptΠ𝑡op\displaystyle\Big{\|}(Q^{(s)})^{2}-\Pi^{(t)}(Q^{(s)})^{2}\Pi^{(t)}\Big{\|}_{% \operatorname{{op}}}=\Big{\|}\Pi^{(s)}(Q^{(s)})^{2}\Pi^{(s)}-\Pi^{(t)}(Q^{(s)}% )^{2}\Pi^{(t)}\Big{\|}_{\operatorname{{op}}}∥ ( italic_Q start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT - roman_Π start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ( italic_Q start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT roman_Π start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ∥ start_POSTSUBSCRIPT roman_op end_POSTSUBSCRIPT = ∥ roman_Π start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT ( italic_Q start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT roman_Π start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT - roman_Π start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ( italic_Q start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT roman_Π start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ∥ start_POSTSUBSCRIPT roman_op end_POSTSUBSCRIPT
(i)(M~(s)(M~(s))op+M~(t)(M~(t))op)=2(Q(s))2opM~(s)(M~(s))M~(t)(M~(t))op𝑖subscriptsubscriptnormsuperscript~𝑀𝑠superscriptsuperscript~𝑀𝑠topopsubscriptnormsuperscript~𝑀𝑡superscriptsuperscript~𝑀𝑡topopabsent2subscriptnormsuperscriptsuperscript𝑄𝑠2opsubscriptnormsuperscript~𝑀𝑠superscriptsuperscript~𝑀𝑠topsuperscript~𝑀𝑡superscriptsuperscript~𝑀𝑡topop\displaystyle\overset{(i)}{\leq}\underbrace{\Big{(}\Big{\|}\widetilde{M}^{(s)}% (\widetilde{M}^{(s)})^{\top}\Big{\|}_{\operatorname{{op}}}+\Big{\|}\widetilde{% M}^{(t)}(\widetilde{M}^{(t)})^{\top}\Big{\|}_{\operatorname{{op}}}\Big{)}}_{=2% }\Big{\|}(Q^{(s)})^{2}\Big{\|}_{\operatorname{{op}}}\Big{\|}\widetilde{M}^{(s)% }(\widetilde{M}^{(s)})^{\top}-\widetilde{M}^{(t)}(\widetilde{M}^{(t)})^{\top}% \Big{\|}_{\operatorname{{op}}}start_OVERACCENT ( italic_i ) end_OVERACCENT start_ARG ≤ end_ARG under⏟ start_ARG ( ∥ over~ start_ARG italic_M end_ARG start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT ( over~ start_ARG italic_M end_ARG start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT ⊤ end_POSTSUPERSCRIPT ∥ start_POSTSUBSCRIPT roman_op end_POSTSUBSCRIPT + ∥ over~ start_ARG italic_M end_ARG start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ( over~ start_ARG italic_M end_ARG start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT ⊤ end_POSTSUPERSCRIPT ∥ start_POSTSUBSCRIPT roman_op end_POSTSUBSCRIPT ) end_ARG start_POSTSUBSCRIPT = 2 end_POSTSUBSCRIPT ∥ ( italic_Q start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT ∥ start_POSTSUBSCRIPT roman_op end_POSTSUBSCRIPT ∥ over~ start_ARG italic_M end_ARG start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT ( over~ start_ARG italic_M end_ARG start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT ⊤ end_POSTSUPERSCRIPT - over~ start_ARG italic_M end_ARG start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ( over~ start_ARG italic_M end_ARG start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT ⊤ end_POSTSUPERSCRIPT ∥ start_POSTSUBSCRIPT roman_op end_POSTSUBSCRIPT
(ii)cρn2n2h1/2𝑖𝑖𝑐superscriptsubscript𝜌𝑛2superscript𝑛2superscript12\displaystyle\overset{(ii)}{\leq}c\rho_{n}^{2}n^{2}h^{1/2}start_OVERACCENT ( italic_i italic_i ) end_OVERACCENT start_ARG ≤ end_ARG italic_c italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT italic_n start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT italic_h start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT (\arabicequation)

where in (i)𝑖(i)( italic_i ), we used ADABDB=ADA±ADBBDB=AD(AB)+(AB)DB𝐴𝐷superscript𝐴top𝐵𝐷superscript𝐵topplus-or-minus𝐴𝐷superscript𝐴top𝐴𝐷superscript𝐵top𝐵𝐷superscript𝐵top𝐴𝐷superscript𝐴𝐵top𝐴𝐵𝐷superscript𝐵topADA^{\top}-BDB^{\top}=ADA^{\top}\pm ADB^{\top}-BDB^{\top}=AD(A-B)^{\top}+(A-B)% DB^{\top}italic_A italic_D italic_A start_POSTSUPERSCRIPT ⊤ end_POSTSUPERSCRIPT - italic_B italic_D italic_B start_POSTSUPERSCRIPT ⊤ end_POSTSUPERSCRIPT = italic_A italic_D italic_A start_POSTSUPERSCRIPT ⊤ end_POSTSUPERSCRIPT ± italic_A italic_D italic_B start_POSTSUPERSCRIPT ⊤ end_POSTSUPERSCRIPT - italic_B italic_D italic_B start_POSTSUPERSCRIPT ⊤ end_POSTSUPERSCRIPT = italic_A italic_D ( italic_A - italic_B ) start_POSTSUPERSCRIPT ⊤ end_POSTSUPERSCRIPT + ( italic_A - italic_B ) italic_D italic_B start_POSTSUPERSCRIPT ⊤ end_POSTSUPERSCRIPT, and (ii)𝑖𝑖(ii)( italic_i italic_i ) holds using Lemma .\arabictheorem and Lemma .\arabictheorem for some constant c𝑐citalic_c that depends polynomially on c2subscript𝑐2c_{2}italic_c start_POSTSUBSCRIPT 2 end_POSTSUBSCRIPT and K𝐾Kitalic_K (recalling the asymptotics in Assumption \arabicsection.\arabicsubsection).

For the remaining terms (i.e., terms II𝐼𝐼IIitalic_I italic_I, III𝐼𝐼𝐼IIIitalic_I italic_I italic_I and IV𝐼𝑉IVitalic_I italic_V), since we are considering the regime where T~1/2nρnc3log1/2(T~+n)superscriptnormal-~𝑇12𝑛subscript𝜌𝑛subscript𝑐3superscript12normal-~𝑇𝑛\widetilde{T}^{1/2}n\rho_{n}\geq c_{3}\log^{1/2}(\widetilde{T}+n)over~ start_ARG italic_T end_ARG start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT italic_n italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT ≥ italic_c start_POSTSUBSCRIPT 3 end_POSTSUBSCRIPT roman_log start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT ( over~ start_ARG italic_T end_ARG + italic_n ), we invoke the techniques in Theorem 1 of Lei & Lin (2022)\arabicfootnote\arabicfootnote\arabicfootnote Specifically, (\arabicequation), (\arabicequation), and (\arabicequation) are analogous to the bound for the term E1subscript𝐸1E_{1}italic_E start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT, E2subscript𝐸2E_{2}italic_E start_POSTSUBSCRIPT 2 end_POSTSUBSCRIPT, and E3subscript𝐸3E_{3}italic_E start_POSTSUBSCRIPT 3 end_POSTSUBSCRIPT together with E4subscript𝐸4E_{4}italic_E start_POSTSUBSCRIPT 4 end_POSTSUBSCRIPT in Theorem 1’s proof in Lei & Lin (2022), respectively. ,

s𝒮(t;r)[diag(Q(t))]2Q(t)diag(Q(t))diag(Q(t))Q(t)opT~nρn2,subscriptnormsubscript𝑠𝒮𝑡𝑟superscriptdelimited-[]diagsuperscript𝑄𝑡2superscript𝑄𝑡diagsuperscript𝑄𝑡diagsuperscript𝑄𝑡superscript𝑄𝑡op~𝑇𝑛superscriptsubscript𝜌𝑛2\displaystyle\Big{\|}\sum_{s\in\mathcal{S}(t;r)}\big{[}\operatorname{{diag}}(Q% ^{(t)})\big{]}^{2}-Q^{(t)}\operatorname{{diag}}(Q^{(t)})-\operatorname{{diag}}% (Q^{(t)})Q^{(t)}\Big{\|}_{\operatorname{{op}}}\leq\widetilde{T}n\rho_{n}^{2},∥ ∑ start_POSTSUBSCRIPT italic_s ∈ caligraphic_S ( italic_t ; italic_r ) end_POSTSUBSCRIPT [ roman_diag ( italic_Q start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ) ] start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT - italic_Q start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT roman_diag ( italic_Q start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ) - roman_diag ( italic_Q start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ) italic_Q start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ∥ start_POSTSUBSCRIPT roman_op end_POSTSUBSCRIPT ≤ over~ start_ARG italic_T end_ARG italic_n italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT , (\arabicequation)
s𝒮(t;r)X(s)P(s)+P(s)X(s)opcT~1/2n3/2ρn3/2log1/2(T~+n),subscriptnormsubscript𝑠𝒮𝑡𝑟superscript𝑋𝑠superscript𝑃𝑠superscript𝑃𝑠superscript𝑋𝑠op𝑐superscript~𝑇12superscript𝑛32superscriptsubscript𝜌𝑛32superscript12~𝑇𝑛\displaystyle\Big{\|}\sum_{s\in\mathcal{S}(t;r)}X^{(s)}P^{(s)}+P^{(s)}X^{(s)}% \Big{\|}_{\operatorname{{op}}}\leq c\cdot\widetilde{T}^{1/2}n^{3/2}\rho_{n}^{3% /2}\log^{1/2}(\widetilde{T}+n),∥ ∑ start_POSTSUBSCRIPT italic_s ∈ caligraphic_S ( italic_t ; italic_r ) end_POSTSUBSCRIPT italic_X start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT italic_P start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT + italic_P start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT italic_X start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT ∥ start_POSTSUBSCRIPT roman_op end_POSTSUBSCRIPT ≤ italic_c ⋅ over~ start_ARG italic_T end_ARG start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT italic_n start_POSTSUPERSCRIPT 3 / 2 end_POSTSUPERSCRIPT italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT start_POSTSUPERSCRIPT 3 / 2 end_POSTSUPERSCRIPT roman_log start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT ( over~ start_ARG italic_T end_ARG + italic_n ) , (\arabicequation)
s𝒮(t;r)(X(s))2D(s)opT~nρn2+cT~1/2nρnlog1/2(T~+n),subscriptnormsubscript𝑠𝒮𝑡𝑟superscriptsuperscript𝑋𝑠2superscript𝐷𝑠op~𝑇𝑛superscriptsubscript𝜌𝑛2𝑐superscript~𝑇12𝑛subscript𝜌𝑛superscript12~𝑇𝑛\displaystyle\Big{\|}\sum_{s\in\mathcal{S}(t;r)}(X^{(s)})^{2}-D^{(s)}\Big{\|}_% {\operatorname{{op}}}\leq\widetilde{T}n\rho_{n}^{2}+c\cdot\widetilde{T}^{1/2}n% \rho_{n}\log^{1/2}(\widetilde{T}+n),∥ ∑ start_POSTSUBSCRIPT italic_s ∈ caligraphic_S ( italic_t ; italic_r ) end_POSTSUBSCRIPT ( italic_X start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT - italic_D start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT ∥ start_POSTSUBSCRIPT roman_op end_POSTSUBSCRIPT ≤ over~ start_ARG italic_T end_ARG italic_n italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT + italic_c ⋅ over~ start_ARG italic_T end_ARG start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT italic_n italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT roman_log start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT ( over~ start_ARG italic_T end_ARG + italic_n ) , (\arabicequation)

the second and third which hold with probability at least 1O((T~+n)1)1𝑂superscriptnormal-~𝑇𝑛11-O((\widetilde{T}+n)^{-1})1 - italic_O ( ( over~ start_ARG italic_T end_ARG + italic_n ) start_POSTSUPERSCRIPT - 1 end_POSTSUPERSCRIPT ).

Consider the eigen-decomposition,

[s𝒮(t;r)Π(t)(Q(s))2Π(t)]=U(t;r)Λ(t;r)(U(t;r)),delimited-[]subscript𝑠𝒮𝑡𝑟superscriptΠ𝑡superscriptsuperscript𝑄𝑠2superscriptΠ𝑡superscript𝑈𝑡𝑟superscriptΛ𝑡𝑟superscriptsuperscript𝑈𝑡𝑟top\Big{[}\sum_{s\in\mathcal{S}(t;r)}\Pi^{(t)}(Q^{(s)})^{2}\Pi^{(t)}\Big{]}=U^{(t% ;r)}\Lambda^{(t;r)}\big{(}U^{(t;r)}\big{)}^{\top},[ ∑ start_POSTSUBSCRIPT italic_s ∈ caligraphic_S ( italic_t ; italic_r ) end_POSTSUBSCRIPT roman_Π start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ( italic_Q start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT roman_Π start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ] = italic_U start_POSTSUPERSCRIPT ( italic_t ; italic_r ) end_POSTSUPERSCRIPT roman_Λ start_POSTSUPERSCRIPT ( italic_t ; italic_r ) end_POSTSUPERSCRIPT ( italic_U start_POSTSUPERSCRIPT ( italic_t ; italic_r ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT ⊤ end_POSTSUPERSCRIPT ,

and observe that the eigen-basis of Q(t)superscript𝑄𝑡Q^{(t)}italic_Q start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT is also U(t;r)superscript𝑈𝑡𝑟U^{(t;r)}italic_U start_POSTSUPERSCRIPT ( italic_t ; italic_r ) end_POSTSUPERSCRIPT (i.e., there is a K×K𝐾𝐾K\times Kitalic_K × italic_K orthonormal matrix Θnormal-Θ\Thetaroman_Θ such that the eigen-basis of Q(t)superscript𝑄𝑡Q^{(t)}italic_Q start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT is equal to U(t;r)Θsuperscript𝑈𝑡𝑟normal-ΘU^{(t;r)}\Thetaitalic_U start_POSTSUPERSCRIPT ( italic_t ; italic_r ) end_POSTSUPERSCRIPT roman_Θ, see Lemma 2.1 of Lei & Rinaldo (2015). Recall that U^(t;r)superscriptnormal-^𝑈𝑡𝑟\widehat{U}^{(t;r)}over^ start_ARG italic_U end_ARG start_POSTSUPERSCRIPT ( italic_t ; italic_r ) end_POSTSUPERSCRIPT is the eigen-basis estimated by KD-SoS. Putting everything together and recalling that the product of two orthonormal matrices yields an orthonormal matrix, we see that with an application of Davis-Kahan (see Theorem 2 of Yu et al. (2014)), there exists a unitary matrix O^K×Knormal-^𝑂superscript𝐾𝐾\widehat{O}\in\mathbb{R}^{K\times K}over^ start_ARG italic_O end_ARG ∈ blackboard_R start_POSTSUPERSCRIPT italic_K × italic_K end_POSTSUPERSCRIPT such that

U^(t;r)O^U(t;r)F23/2K1/2[s𝒮(t;r)(A(s))2D(s)][s𝒮(t;r)Π(t)(Q(s))2Π(t)]opλmin(s𝒮(t;r)Π(t)(Q(s))2Π(t))subscriptnormsuperscript^𝑈𝑡𝑟^𝑂superscript𝑈𝑡𝑟𝐹superscript232superscript𝐾12subscriptnormdelimited-[]subscript𝑠𝒮𝑡𝑟superscriptsuperscript𝐴𝑠2superscript𝐷𝑠delimited-[]subscript𝑠𝒮𝑡𝑟superscriptΠ𝑡superscriptsuperscript𝑄𝑠2superscriptΠ𝑡opsubscript𝜆subscript𝑠𝒮𝑡𝑟superscriptΠ𝑡superscriptsuperscript𝑄𝑠2superscriptΠ𝑡\displaystyle\big{\|}\widehat{U}^{(t;r)}\widehat{O}-U^{(t;r)}\big{\|}_{F}\leq% \frac{2^{3/2}K^{1/2}\big{\|}\big{[}\sum_{s\in\mathcal{S}(t;r)}(A^{(s)})^{2}-D^% {(s)}\big{]}-\big{[}\sum_{s\in\mathcal{S}(t;r)}\Pi^{(t)}(Q^{(s)})^{2}\Pi^{(t)}% \big{]}\big{\|}_{\operatorname{{op}}}}{\lambda_{\min}\big{(}\sum_{s\in\mathcal% {S}(t;r)}\Pi^{(t)}(Q^{(s)})^{2}\Pi^{(t)}\big{)}}∥ over^ start_ARG italic_U end_ARG start_POSTSUPERSCRIPT ( italic_t ; italic_r ) end_POSTSUPERSCRIPT over^ start_ARG italic_O end_ARG - italic_U start_POSTSUPERSCRIPT ( italic_t ; italic_r ) end_POSTSUPERSCRIPT ∥ start_POSTSUBSCRIPT italic_F end_POSTSUBSCRIPT ≤ divide start_ARG 2 start_POSTSUPERSCRIPT 3 / 2 end_POSTSUPERSCRIPT italic_K start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT ∥ [ ∑ start_POSTSUBSCRIPT italic_s ∈ caligraphic_S ( italic_t ; italic_r ) end_POSTSUBSCRIPT ( italic_A start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT - italic_D start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT ] - [ ∑ start_POSTSUBSCRIPT italic_s ∈ caligraphic_S ( italic_t ; italic_r ) end_POSTSUBSCRIPT roman_Π start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ( italic_Q start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT roman_Π start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ] ∥ start_POSTSUBSCRIPT roman_op end_POSTSUBSCRIPT end_ARG start_ARG italic_λ start_POSTSUBSCRIPT roman_min end_POSTSUBSCRIPT ( ∑ start_POSTSUBSCRIPT italic_s ∈ caligraphic_S ( italic_t ; italic_r ) end_POSTSUBSCRIPT roman_Π start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ( italic_Q start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT roman_Π start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ) end_ARG
(i)ch1/2T~n2ρn2+T~nρn2+T~1/2n3/2ρn3/2log1/2(T~+n)+T~nρn2+T~1/2nρnlog1/2(T~+n)(1ch1/2)+T~n2ρn2𝑖𝑐superscript12~𝑇superscript𝑛2superscriptsubscript𝜌𝑛2~𝑇𝑛superscriptsubscript𝜌𝑛2superscript~𝑇12superscript𝑛32superscriptsubscript𝜌𝑛32superscript12~𝑇𝑛~𝑇𝑛superscriptsubscript𝜌𝑛2superscript~𝑇12𝑛subscript𝜌𝑛superscript12~𝑇𝑛subscript1𝑐superscript12~𝑇superscript𝑛2superscriptsubscript𝜌𝑛2\displaystyle\overset{(i)}{\leq}c\cdot\frac{h^{1/2}\widetilde{T}n^{2}\rho_{n}^% {2}+\widetilde{T}n\rho_{n}^{2}+\widetilde{T}^{1/2}n^{3/2}\rho_{n}^{3/2}\log^{1% /2}(\widetilde{T}+n)+\widetilde{T}n\rho_{n}^{2}+\widetilde{T}^{1/2}n\rho_{n}% \log^{1/2}(\widetilde{T}+n)}{(1-ch^{1/2})_{+}\cdot\widetilde{T}n^{2}\rho_{n}^{% 2}}start_OVERACCENT ( italic_i ) end_OVERACCENT start_ARG ≤ end_ARG italic_c ⋅ divide start_ARG italic_h start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT over~ start_ARG italic_T end_ARG italic_n start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT + over~ start_ARG italic_T end_ARG italic_n italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT + over~ start_ARG italic_T end_ARG start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT italic_n start_POSTSUPERSCRIPT 3 / 2 end_POSTSUPERSCRIPT italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT start_POSTSUPERSCRIPT 3 / 2 end_POSTSUPERSCRIPT roman_log start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT ( over~ start_ARG italic_T end_ARG + italic_n ) + over~ start_ARG italic_T end_ARG italic_n italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT + over~ start_ARG italic_T end_ARG start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT italic_n italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT roman_log start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT ( over~ start_ARG italic_T end_ARG + italic_n ) end_ARG start_ARG ( 1 - italic_c italic_h start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT ) start_POSTSUBSCRIPT + end_POSTSUBSCRIPT ⋅ over~ start_ARG italic_T end_ARG italic_n start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT end_ARG
(ii)ch1/2(1ch1/2)++2c(1ch1/2)+n+clog1/2(T~+n)(1ch1/2)+T~1/2nρn,𝑖𝑖𝑐superscript12subscript1𝑐superscript122𝑐subscript1𝑐superscript12𝑛𝑐superscript12~𝑇𝑛subscript1𝑐superscript12superscript~𝑇12𝑛subscript𝜌𝑛\displaystyle\overset{(ii)}{\leq}\frac{ch^{1/2}}{(1-ch^{1/2})_{+}}+\frac{2c}{(% 1-ch^{1/2})_{+}\cdot n}+\frac{c\log^{1/2}(\widetilde{T}+n)}{(1-ch^{1/2})_{+}% \cdot\widetilde{T}^{1/2}n\rho_{n}},start_OVERACCENT ( italic_i italic_i ) end_OVERACCENT start_ARG ≤ end_ARG divide start_ARG italic_c italic_h start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT end_ARG start_ARG ( 1 - italic_c italic_h start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT ) start_POSTSUBSCRIPT + end_POSTSUBSCRIPT end_ARG + divide start_ARG 2 italic_c end_ARG start_ARG ( 1 - italic_c italic_h start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT ) start_POSTSUBSCRIPT + end_POSTSUBSCRIPT ⋅ italic_n end_ARG + divide start_ARG italic_c roman_log start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT ( over~ start_ARG italic_T end_ARG + italic_n ) end_ARG start_ARG ( 1 - italic_c italic_h start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT ) start_POSTSUBSCRIPT + end_POSTSUBSCRIPT ⋅ over~ start_ARG italic_T end_ARG start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT italic_n italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT end_ARG ,

where (i)𝑖(i)( italic_i ) holds with an application of Lemma \arabicsection.\arabictheorem as well as Equations (\arabicequation), (\arabicequation), (\arabicequation), and (\arabicequation), and (ii)𝑖𝑖(ii)( italic_i italic_i ) holds since nρnc1𝑛subscript𝜌𝑛subscript𝑐1n\rho_{n}\leq c_{1}italic_n italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT ≤ italic_c start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT (due to Assumption \arabicsection.\arabicsubsection).

Lastly, we wish to convert a Frobenius norm bound between the true and estimated orthonormal matrices into a misclustering error rate. To do this, from Lemma 2.1 of Lei & Rinaldo (2015), we know the minimum Euclidean distance between distinct rows of U(t;r)superscript𝑈𝑡𝑟U^{(t;r)}italic_U start_POSTSUPERSCRIPT ( italic_t ; italic_r ) end_POSTSUPERSCRIPT is at least c/n𝑐𝑛c/\sqrt{n}italic_c / square-root start_ARG italic_n end_ARG. Hence, by invoking Lemma D.1 of Lei & Lin (2022) (i.e., a simplification of Lemma 5.3 of Lei & Rinaldo (2015)), the number of misclustered nodes by spectral clustering is no larger than

c(hn(1ch1/2)+2+1(1ch1/2)+2n+log(T~+n)(1ch1/2)+2T~nρn2).𝑐𝑛superscriptsubscript1𝑐superscript1221superscriptsubscript1𝑐superscript122𝑛~𝑇𝑛superscriptsubscript1𝑐superscript122~𝑇𝑛superscriptsubscript𝜌𝑛2c\cdot\Big{(}\frac{hn}{(1-ch^{1/2})_{+}^{2}}+\frac{1}{(1-ch^{1/2})_{+}^{2}% \cdot n}+\frac{\log(\widetilde{T}+n)}{(1-ch^{1/2})_{+}^{2}\cdot\widetilde{T}n% \rho_{n}^{2}}\Big{)}.italic_c ⋅ ( divide start_ARG italic_h italic_n end_ARG start_ARG ( 1 - italic_c italic_h start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT ) start_POSTSUBSCRIPT + end_POSTSUBSCRIPT start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT end_ARG + divide start_ARG 1 end_ARG start_ARG ( 1 - italic_c italic_h start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT ) start_POSTSUBSCRIPT + end_POSTSUBSCRIPT start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT ⋅ italic_n end_ARG + divide start_ARG roman_log ( over~ start_ARG italic_T end_ARG + italic_n ) end_ARG start_ARG ( 1 - italic_c italic_h start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT ) start_POSTSUBSCRIPT + end_POSTSUBSCRIPT start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT ⋅ over~ start_ARG italic_T end_ARG italic_n italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT end_ARG ) .

We divide the above term by n𝑛nitalic_n to obtain the percentage of misclustered nodes.

Proof for Corollary \arabicsection.\arabictheorem.

Proof .\arabictheorem.

Let c𝑐citalic_c be a constant that can vary from term to term, depending only on the constants c1subscript𝑐1c_{1}italic_c start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT, c2subscript𝑐2c_{2}italic_c start_POSTSUBSCRIPT 2 end_POSTSUBSCRIPT, c3subscript𝑐3c_{3}italic_c start_POSTSUBSCRIPT 3 end_POSTSUBSCRIPT, cδsubscript𝑐𝛿c_{\delta}italic_c start_POSTSUBSCRIPT italic_δ end_POSTSUBSCRIPT, and K𝐾Kitalic_K. We seek to derive a the near-optimal bandwidth r*superscript𝑟r^{*}italic_r start_POSTSUPERSCRIPT * end_POSTSUPERSCRIPT. Consider the rate in Theorem \arabicsection.\arabictheorem. We will only consider the regime where

γr1,much-less-than𝛾𝑟1\gamma r\ll 1,italic_γ italic_r ≪ 1 ,

which would mean the leading term in the rate in Theorem \arabicsection.\arabictheorem is upper-bounded by a constant, i.e.,

1(1(γr+log(n)/n)1/2)+2c.much-less-than1subscriptsuperscript1superscript𝛾𝑟𝑛𝑛122𝑐\frac{1}{(1-(\gamma r+\log(n)/n)^{1/2})^{2}_{+}}\ll c.divide start_ARG 1 end_ARG start_ARG ( 1 - ( italic_γ italic_r + roman_log ( italic_n ) / italic_n ) start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT start_POSTSUBSCRIPT + end_POSTSUBSCRIPT end_ARG ≪ italic_c .

This allows us to ignore this leading term when deriving the functional form of r*superscript𝑟r^{*}italic_r start_POSTSUPERSCRIPT * end_POSTSUPERSCRIPT.

Next, observe that if we only want to derive the optimal bandwidth r*superscript𝑟r^{*}italic_r start_POSTSUPERSCRIPT * end_POSTSUPERSCRIPT up to logarithmic factors, we can define

r*=minr[0,1]cγr=A(r)+log(T+n)rTn2ρn2=B(r).superscript𝑟subscript𝑟01subscript𝑐𝛾𝑟absent𝐴𝑟subscript𝑇𝑛𝑟𝑇superscript𝑛2superscriptsubscript𝜌𝑛2absent𝐵𝑟r^{*}=\min_{r\in[0,1]}\underbrace{c\cdot\gamma r}_{=A(r)}+\underbrace{\frac{% \log(T+n)}{rTn^{2}\rho_{n}^{2}}}_{=B(r)}.italic_r start_POSTSUPERSCRIPT * end_POSTSUPERSCRIPT = roman_min start_POSTSUBSCRIPT italic_r ∈ [ 0 , 1 ] end_POSTSUBSCRIPT under⏟ start_ARG italic_c ⋅ italic_γ italic_r end_ARG start_POSTSUBSCRIPT = italic_A ( italic_r ) end_POSTSUBSCRIPT + under⏟ start_ARG divide start_ARG roman_log ( italic_T + italic_n ) end_ARG start_ARG italic_r italic_T italic_n start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT end_ARG end_ARG start_POSTSUBSCRIPT = italic_B ( italic_r ) end_POSTSUBSCRIPT .

Setting the derivative of A(r)+B(r)𝐴𝑟𝐵𝑟A(r)+B(r)italic_A ( italic_r ) + italic_B ( italic_r ) to be 0 yields,

0=cγ1(r*)2Tn2ρn2r*=c1(γT)1/2nρn,formulae-sequence0𝑐𝛾1superscriptsuperscript𝑟2𝑇superscript𝑛2superscriptsubscript𝜌𝑛2superscript𝑟𝑐1superscript𝛾𝑇12𝑛subscript𝜌𝑛0=c\cdot\gamma-\frac{1}{(r^{*})^{2}Tn^{2}\rho_{n}^{2}}\quad\Longrightarrow% \quad r^{*}=c\cdot\frac{1}{(\gamma T)^{1/2}n\rho_{n}},0 = italic_c ⋅ italic_γ - divide start_ARG 1 end_ARG start_ARG ( italic_r start_POSTSUPERSCRIPT * end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT italic_T italic_n start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT end_ARG ⟹ italic_r start_POSTSUPERSCRIPT * end_POSTSUPERSCRIPT = italic_c ⋅ divide start_ARG 1 end_ARG start_ARG ( italic_γ italic_T ) start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT italic_n italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT end_ARG ,

for some constant c𝑐citalic_c that depends on c1subscript𝑐1c_{1}italic_c start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT, c2subscript𝑐2c_{2}italic_c start_POSTSUBSCRIPT 2 end_POSTSUBSCRIPT, c3subscript𝑐3c_{3}italic_c start_POSTSUBSCRIPT 3 end_POSTSUBSCRIPT, cδsubscript𝑐𝛿c_{\delta}italic_c start_POSTSUBSCRIPT italic_δ end_POSTSUBSCRIPT, and K𝐾Kitalic_K.

Proof .\arabictheorem.

The upper-bound of the relative Hamming distance depends on if r*1normal-→superscript𝑟1r^{*}\rightarrow 1italic_r start_POSTSUPERSCRIPT * end_POSTSUPERSCRIPT → 1 or r*0normal-→superscript𝑟0r^{*}\rightarrow 0italic_r start_POSTSUPERSCRIPT * end_POSTSUPERSCRIPT → 0 based on the asymptotic sequence of n𝑛nitalic_n, T𝑇Titalic_T, γ𝛾\gammaitalic_γ and ρnsubscript𝜌𝑛\rho_{n}italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT. Recall that by assumptions in Theorem \arabicsection.\arabictheorem, we require

(rT+1)1/2nρn=ω(log1/2(rT+n+1)).superscript𝑟𝑇112𝑛subscript𝜌𝑛𝜔superscript12𝑟𝑇𝑛1\displaystyle(rT+1)^{1/2}n\rho_{n}=\omega\Big{(}\log^{1/2}(rT+n+1)\Big{)}.( italic_r italic_T + 1 ) start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT italic_n italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT = italic_ω ( roman_log start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT ( italic_r italic_T + italic_n + 1 ) ) . (\arabicequation)
  • Based on Corollary \arabicsection.\arabictheorem, the scenario r*1superscript𝑟1r^{*}\rightarrow 1italic_r start_POSTSUPERSCRIPT * end_POSTSUPERSCRIPT → 1 occurs if

    1(γT)1/2nρn(γT)1/2nρn0.formulae-sequence1superscript𝛾𝑇12𝑛subscript𝜌𝑛iffsuperscript𝛾𝑇12𝑛subscript𝜌𝑛0\frac{1}{(\gamma T)^{1/2}n\rho_{n}}\rightarrow\infty\quad\iff\quad(\gamma T)^{% 1/2}n\rho_{n}\rightarrow 0.divide start_ARG 1 end_ARG start_ARG ( italic_γ italic_T ) start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT italic_n italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT end_ARG → ∞ ⇔ ( italic_γ italic_T ) start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT italic_n italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT → 0 .

    We also require that γr*0𝛾superscript𝑟0\gamma r^{*}\rightarrow 0italic_γ italic_r start_POSTSUPERSCRIPT * end_POSTSUPERSCRIPT → 0 as a necessary condition for the relative Hamming distance in Theorem \arabicsection.\arabictheorem to converge to 0. To ensure this, we will require asymptotically

    γ0.𝛾0\gamma\rightarrow 0.italic_γ → 0 . (\arabicequation)

    Furthremore, the requirement (\arabicequation) is satisfied if

    T1/2nρn=ω(log1/2(T+n)).superscript𝑇12𝑛subscript𝜌𝑛𝜔superscript12𝑇𝑛T^{1/2}n\rho_{n}=\omega\big{(}\log^{1/2}(T+n)\big{)}.italic_T start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT italic_n italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT = italic_ω ( roman_log start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT ( italic_T + italic_n ) ) . (\arabicequation)

    To upper-bound the relative Hamming error, since γr*0𝛾superscript𝑟0\gamma r^{*}\rightarrow 0italic_γ italic_r start_POSTSUPERSCRIPT * end_POSTSUPERSCRIPT → 0, for any constant c𝑐citalic_c, this means somewhere along this asymptotic sequence of {n,T,γ,ρn}𝑛𝑇𝛾subscript𝜌𝑛\{n,T,\gamma,\rho_{n}\}{ italic_n , italic_T , italic_γ , italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT }, we are guaranteed γr+log(n)/nc𝛾𝑟𝑛𝑛𝑐\gamma r+\log(n)/n\leq citalic_γ italic_r + roman_log ( italic_n ) / italic_n ≤ italic_c for the remainder of the asymptotic sequence. Then,

    L(G(t),G^(t))=O(γ+log(n)n+1n2+log(T+n)Tn2ρn2),𝐿superscript𝐺𝑡superscript^𝐺𝑡𝑂𝛾𝑛𝑛1superscript𝑛2𝑇𝑛𝑇superscript𝑛2subscriptsuperscript𝜌2𝑛L\big{(}G^{(t)},\widehat{G}^{(t)}\big{)}=O\Big{(}\gamma+\frac{\log(n)}{n}+% \frac{1}{n^{2}}+\frac{\log(T+n)}{Tn^{2}\rho^{2}_{n}}\Big{)},italic_L ( italic_G start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT , over^ start_ARG italic_G end_ARG start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ) = italic_O ( italic_γ + divide start_ARG roman_log ( italic_n ) end_ARG start_ARG italic_n end_ARG + divide start_ARG 1 end_ARG start_ARG italic_n start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT end_ARG + divide start_ARG roman_log ( italic_T + italic_n ) end_ARG start_ARG italic_T italic_n start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT italic_ρ start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT end_ARG ) ,

    By (\arabicequation) and (\arabicequation), we are ensured that L(G(t),G^(t))𝐿superscript𝐺𝑡superscript^𝐺𝑡L\big{(}G^{(t)},\widehat{G}^{(t)}\big{)}italic_L ( italic_G start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT , over^ start_ARG italic_G end_ARG start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ) converges to 0.

  • Based on Corollary \arabicsection.\arabictheorem, the scenario r*0superscript𝑟0r^{*}\rightarrow 0italic_r start_POSTSUPERSCRIPT * end_POSTSUPERSCRIPT → 0 occurs if

    1(γT)1/2nρn0(γT)1/2nρn.formulae-sequence1superscript𝛾𝑇12𝑛subscript𝜌𝑛0iffsuperscript𝛾𝑇12𝑛subscript𝜌𝑛\frac{1}{(\gamma T)^{1/2}n\rho_{n}}\rightarrow 0\quad\iff\quad(\gamma T)^{1/2}% n\rho_{n}\rightarrow\infty.divide start_ARG 1 end_ARG start_ARG ( italic_γ italic_T ) start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT italic_n italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT end_ARG → 0 ⇔ ( italic_γ italic_T ) start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT italic_n italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT → ∞ . (\arabicequation)

    We also require that γr*0𝛾superscript𝑟0\gamma r^{*}\rightarrow 0italic_γ italic_r start_POSTSUPERSCRIPT * end_POSTSUPERSCRIPT → 0 as a necessary condition for the relative Hamming distance in Theorem \arabicsection.\arabictheorem to converge to 0. To ensure this, using the rate of r*superscript𝑟r^{*}italic_r start_POSTSUPERSCRIPT * end_POSTSUPERSCRIPT derived in Corollary \arabicsection.\arabictheorem, we require asymptotically

    γr*=γ1/2T1/2nρn0γ=o(T(nρn)2),formulae-sequence𝛾superscript𝑟superscript𝛾12superscript𝑇12𝑛subscript𝜌𝑛0iff𝛾𝑜𝑇superscript𝑛subscript𝜌𝑛2\quad\gamma r^{*}=\frac{\gamma^{1/2}}{T^{1/2}n\rho_{n}}\rightarrow 0\quad\iff% \quad\gamma=o\big{(}T(n\rho_{n})^{2}\big{)},italic_γ italic_r start_POSTSUPERSCRIPT * end_POSTSUPERSCRIPT = divide start_ARG italic_γ start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT end_ARG start_ARG italic_T start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT italic_n italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT end_ARG → 0 ⇔ italic_γ = italic_o ( italic_T ( italic_n italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT ) start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT ) , (\arabicequation)

    which upper-bounds the maximum γ𝛾\gammaitalic_γ before KD-SoS is no longer consistent. Furthermore, the requirement (\arabicequation) is satisfied based on the bandwidth r*superscript𝑟r^{*}italic_r start_POSTSUPERSCRIPT * end_POSTSUPERSCRIPT in Corollary \arabicsection.\arabictheorem if

    (Tγ)1/2nρn=ω(log1/2(T+n)).superscript𝑇𝛾12𝑛subscript𝜌𝑛𝜔superscript12𝑇𝑛\Big{(}\frac{T}{\gamma}\Big{)}^{1/2}n\rho_{n}=\omega\big{(}\log^{1/2}(T+n)\big% {)}.( divide start_ARG italic_T end_ARG start_ARG italic_γ end_ARG ) start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT italic_n italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT = italic_ω ( roman_log start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT ( italic_T + italic_n ) ) . (\arabicequation)

    An asymptotic regime that would satisfy (\arabicequation), (\arabicequation), and (\arabicequation) is

    γ is increasing and γ=o(T(nρn)2log(T+n)).𝛾 is increasing and 𝛾𝑜𝑇superscript𝑛subscript𝜌𝑛2𝑇𝑛\gamma\text{ is increasing and }\gamma=o\Big{(}\frac{T(n\rho_{n})^{2}}{\log(T+% n)}\Big{)}.italic_γ is increasing and italic_γ = italic_o ( divide start_ARG italic_T ( italic_n italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT ) start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT end_ARG start_ARG roman_log ( italic_T + italic_n ) end_ARG ) . (\arabicequation)

    To upper-bound the relative Hamming error, since γr*0𝛾superscript𝑟0\gamma r^{*}\rightarrow 0italic_γ italic_r start_POSTSUPERSCRIPT * end_POSTSUPERSCRIPT → 0, for any constant c𝑐citalic_c, this means somewhere along this asymptotic sequence of {n,T,γ,ρn}𝑛𝑇𝛾subscript𝜌𝑛\{n,T,\gamma,\rho_{n}\}{ italic_n , italic_T , italic_γ , italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT }, we are guaranteed γr+log(n)/nc𝛾𝑟𝑛𝑛𝑐\gamma r+\log(n)/n\leq citalic_γ italic_r + roman_log ( italic_n ) / italic_n ≤ italic_c for the remainder of the asymptotic sequence. Then,

    L(G(t),G^(t))=O(γ1/2T1/2nρn+log(n)n+1n2+γ1/2log(T1/2/(γ1/2nρn)+n)T1/2nρn).𝐿superscript𝐺𝑡superscript^𝐺𝑡𝑂superscript𝛾12superscript𝑇12𝑛subscript𝜌𝑛𝑛𝑛1superscript𝑛2superscript𝛾12superscript𝑇12superscript𝛾12𝑛subscript𝜌𝑛𝑛superscript𝑇12𝑛subscript𝜌𝑛\displaystyle L\big{(}G^{(t)},\widehat{G}^{(t)}\big{)}=O\Big{(}\frac{\gamma^{1% /2}}{T^{1/2}n\rho_{n}}+\frac{\log(n)}{n}+\frac{1}{n^{2}}+\frac{\gamma^{1/2}% \log(T^{1/2}/(\gamma^{1/2}n\rho_{n})+n)}{T^{1/2}n\rho_{n}}\Big{)}.italic_L ( italic_G start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT , over^ start_ARG italic_G end_ARG start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ) = italic_O ( divide start_ARG italic_γ start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT end_ARG start_ARG italic_T start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT italic_n italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT end_ARG + divide start_ARG roman_log ( italic_n ) end_ARG start_ARG italic_n end_ARG + divide start_ARG 1 end_ARG start_ARG italic_n start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT end_ARG + divide start_ARG italic_γ start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT roman_log ( italic_T start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT / ( italic_γ start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT italic_n italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT ) + italic_n ) end_ARG start_ARG italic_T start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT italic_n italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT end_ARG ) .

    By (\arabicequation), we are ensured that L(G(t),G^(t))𝐿superscript𝐺𝑡superscript^𝐺𝑡L\big{(}G^{(t)},\widehat{G}^{(t)}\big{)}italic_L ( italic_G start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT , over^ start_ARG italic_G end_ARG start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ) converges to 0.

Hence, we are done.

Proof of Proposition \arabicsection.\arabictheorem.

Proof .\arabictheorem.

We split the proof into two parts.

Deterministic component. Here, we prove if more than n/2normal-n2n/2italic_n / 2 nodes change memberships between M(t)superscriptnormal-Mnormal-tM^{(t)}italic_M start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT and M(t+1/T)superscriptnormal-Mnormal-t1normal-TM^{(t+1/T)}italic_M start_POSTSUPERSCRIPT ( italic_t + 1 / italic_T ) end_POSTSUPERSCRIPT for a particular t𝒯\{1}normal-tnormal-\𝒯1t\in\mathcal{T}\backslash\{1\}italic_t ∈ caligraphic_T \ { 1 }, then M(t)superscriptnormal-Mnormal-tM^{(t)}italic_M start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT and M(t+1/T)superscriptnormal-Mnormal-t1normal-TM^{(t+1/T)}italic_M start_POSTSUPERSCRIPT ( italic_t + 1 / italic_T ) end_POSTSUPERSCRIPT are not alignable. Then, by definition, the entire sequence of memberships is not alignable.

Consider the confusion matrix C{0,,n}K×K𝐶superscript0normal-…𝑛𝐾𝐾C\in\{0,\ldots,n\}^{K\times K}italic_C ∈ { 0 , … , italic_n } start_POSTSUPERSCRIPT italic_K × italic_K end_POSTSUPERSCRIPT formed from M(t)superscript𝑀𝑡M^{(t)}italic_M start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT and M(t+1/T)superscript𝑀𝑡1𝑇M^{(t+1/T)}italic_M start_POSTSUPERSCRIPT ( italic_t + 1 / italic_T ) end_POSTSUPERSCRIPT. Since more than n/2𝑛2n/2italic_n / 2 nodes change memberships, then by definition, the sum of the off-diagonal entries in C𝐶Citalic_C must be larger than n/2𝑛2n/2italic_n / 2, and the sum of the diagonal entries in C𝐶Citalic_C must be smaller than n/2𝑛2n/2italic_n / 2. Hence, there must exist a diagonal entry in C𝐶Citalic_C whereby it is smaller than its respective column-sum or row-sum. Hence, it must be the case that either C𝐶Citalic_C or Csuperscript𝐶topC^{\top}italic_C start_POSTSUPERSCRIPT ⊤ end_POSTSUPERSCRIPT is not diagonally dominant, and hence, M(t)superscript𝑀𝑡M^{(t)}italic_M start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT and M(t+1/T)superscript𝑀𝑡1𝑇M^{(t+1/T)}italic_M start_POSTSUPERSCRIPT ( italic_t + 1 / italic_T ) end_POSTSUPERSCRIPT is not alignable.

Probabilistic component. Here, we prove that if γnormal-γ\gammaitalic_γ is large relative to Tnormal-TTitalic_T, then there is a non-vanishing probability that more than n/2normal-n2n/2italic_n / 2 nodes change memberships between M(t)superscriptnormal-Mnormal-tM^{(t)}italic_M start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT and M(t+1/T)superscriptnormal-Mnormal-t1normal-TM^{(t+1/T)}italic_M start_POSTSUPERSCRIPT ( italic_t + 1 / italic_T ) end_POSTSUPERSCRIPT for some time t𝒯\{1}normal-tnormal-\𝒯1t\in\mathcal{T}\backslash\{1\}italic_t ∈ caligraphic_T \ { 1 }.

Towards this end, let X(t)superscript𝑋𝑡X^{(t)}italic_X start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT denote the total number of instances when nodes change communities between time t𝑡titalic_t and t+1/T𝑡1𝑇t+1/Titalic_t + 1 / italic_T based on Assumption \arabicsection.\arabicsubsection. (Note, this random variable is not a Poisson, since the Poisson process denotes the number of instances a node changes membership, not the number of unique nodes change membership.) We are interested in when the probability X(t)n/2superscript𝑋𝑡𝑛2X^{(t)}\geq n/2italic_X start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ≥ italic_n / 2 for some t{1/T,,(T1)/T}𝑡1𝑇normal-…𝑇1𝑇t\in\{1/T,\ldots,(T-1)/T\}italic_t ∈ { 1 / italic_T , … , ( italic_T - 1 ) / italic_T } is bounded away from 0. That is,

(X(t)n/2, for some t{1/T,,(T1)/T})formulae-sequencesuperscript𝑋𝑡𝑛2 for some 𝑡1𝑇𝑇1𝑇\displaystyle\mathbb{P}\Big{(}X^{(t)}\geq n/2,\text{ for some }t\in\{1/T,% \ldots,(T-1)/T\}\Big{)}blackboard_P ( italic_X start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ≥ italic_n / 2 , for some italic_t ∈ { 1 / italic_T , … , ( italic_T - 1 ) / italic_T } )
=1(X(t)n/2, for all t{1/T,,(T1)/T})absent1formulae-sequencesuperscript𝑋𝑡𝑛2 for all 𝑡1𝑇𝑇1𝑇\displaystyle=1-\mathbb{P}\Big{(}X^{(t)}\leq n/2,\text{ for all }t\in\{1/T,% \ldots,(T-1)/T\}\Big{)}= 1 - blackboard_P ( italic_X start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ≤ italic_n / 2 , for all italic_t ∈ { 1 / italic_T , … , ( italic_T - 1 ) / italic_T } )
=1(X(1/T)n/2)T1=1[1(X(1/T)n/2)]T1absent1superscriptsuperscript𝑋1𝑇𝑛2𝑇11superscriptdelimited-[]1superscript𝑋1𝑇𝑛2𝑇1\displaystyle=1-\mathbb{P}\Big{(}X^{(1/T)}\leq n/2\Big{)}^{T-1}=1-\Big{[}1-% \mathbb{P}\Big{(}X^{(1/T)}\geq n/2\Big{)}\Big{]}^{T-1}= 1 - blackboard_P ( italic_X start_POSTSUPERSCRIPT ( 1 / italic_T ) end_POSTSUPERSCRIPT ≤ italic_n / 2 ) start_POSTSUPERSCRIPT italic_T - 1 end_POSTSUPERSCRIPT = 1 - [ 1 - blackboard_P ( italic_X start_POSTSUPERSCRIPT ( 1 / italic_T ) end_POSTSUPERSCRIPT ≥ italic_n / 2 ) ] start_POSTSUPERSCRIPT italic_T - 1 end_POSTSUPERSCRIPT (\arabicequation)

To lower-bound the RHS of (\arabicequation), consider a probability p𝑝pitalic_p that a node changes membership in a time interval of length 1/T1𝑇1/T1 / italic_T. Since each node changes memberships independently of one another, the total number of nodes that change memberships is modeled as X(1/T)=𝐵𝑖𝑛𝑜𝑚𝑖𝑎𝑙(n,p)superscript𝑋1𝑇𝐵𝑖𝑛𝑜𝑚𝑖𝑎𝑙𝑛𝑝X^{(1/T)}=\text{Binomial}(n,p)italic_X start_POSTSUPERSCRIPT ( 1 / italic_T ) end_POSTSUPERSCRIPT = Binomial ( italic_n , italic_p ) for a p𝑝pitalic_p to be determined, and we are interested the probability that X(1/T)n/2superscript𝑋1𝑇𝑛2X^{(1/T)}\geq n/2italic_X start_POSTSUPERSCRIPT ( 1 / italic_T ) end_POSTSUPERSCRIPT ≥ italic_n / 2. Certainly, if p=1/2𝑝12p=1/2italic_p = 1 / 2, then the probability of X(1/T)n/2superscript𝑋1𝑇𝑛2X^{(1/T)}\geq n/2italic_X start_POSTSUPERSCRIPT ( 1 / italic_T ) end_POSTSUPERSCRIPT ≥ italic_n / 2 is strictly bounded away from 0. Hence, we are interested in a p𝑝pitalic_p less than 1/2121/21 / 2.

Towards this end, invoking a lower-bound of the upper-tail of a Binomial (see Chernoff-Hoeffding bounds in references such as Pelekis (2016)), observe that

(X(1/T)n/2)12nexp(nD(12||p)),\mathbb{P}\big{(}X^{(1/T)}\geq n/2\big{)}\geq\frac{1}{\sqrt{2n}}\exp\Big{(}-nD% \big{(}\frac{1}{2}\;||\;p\big{)}\Big{)},blackboard_P ( italic_X start_POSTSUPERSCRIPT ( 1 / italic_T ) end_POSTSUPERSCRIPT ≥ italic_n / 2 ) ≥ divide start_ARG 1 end_ARG start_ARG square-root start_ARG 2 italic_n end_ARG end_ARG roman_exp ( - italic_n italic_D ( divide start_ARG 1 end_ARG start_ARG 2 end_ARG | | italic_p ) ) , (\arabicequation)

where

D(12||p)\displaystyle D\big{(}\frac{1}{2}\;||\;p\big{)}italic_D ( divide start_ARG 1 end_ARG start_ARG 2 end_ARG | | italic_p ) =12log(1/2p)+12log(1/21p)absent1212𝑝12121𝑝\displaystyle=\frac{1}{2}\cdot\log\Big{(}\frac{1/2}{p}\Big{)}+\frac{1}{2}\cdot% \log\Big{(}\frac{1/2}{1-p}\Big{)}= divide start_ARG 1 end_ARG start_ARG 2 end_ARG ⋅ roman_log ( divide start_ARG 1 / 2 end_ARG start_ARG italic_p end_ARG ) + divide start_ARG 1 end_ARG start_ARG 2 end_ARG ⋅ roman_log ( divide start_ARG 1 / 2 end_ARG start_ARG 1 - italic_p end_ARG )
=12log(2p)+12log(2(1p))absent122𝑝1221𝑝\displaystyle=\frac{-1}{2}\cdot\log\big{(}2\cdot p\big{)}+\frac{-1}{2}\cdot% \log\big{(}2\cdot(1-p)\big{)}= divide start_ARG - 1 end_ARG start_ARG 2 end_ARG ⋅ roman_log ( 2 ⋅ italic_p ) + divide start_ARG - 1 end_ARG start_ARG 2 end_ARG ⋅ roman_log ( 2 ⋅ ( 1 - italic_p ) )
=log[(4p(1p))1/2].absentsuperscript4𝑝1𝑝12\displaystyle=\log\Big{[}\big{(}4\cdot p\cdot(1-p)\big{)}^{-1/2}\Big{]}.= roman_log [ ( 4 ⋅ italic_p ⋅ ( 1 - italic_p ) ) start_POSTSUPERSCRIPT - 1 / 2 end_POSTSUPERSCRIPT ] . (\arabicequation)

For reasons we will shortly discuss, we are interested when (\arabicequation) is lower-bounded by 1/(T1)1𝑇11/(T-1)1 / ( italic_T - 1 ). Hence, combining (\arabicequation) with (\arabicequation), we are interested in x𝑥xitalic_x such that

(X(0)n/2)12n((4p(1p))n/2)1T1,superscript𝑋0𝑛212𝑛superscript4𝑝1𝑝𝑛21𝑇1\mathbb{P}\big{(}X^{(0)}\geq n/2\big{)}\geq\frac{1}{\sqrt{2n}}\cdot\Big{(}\big% {(}4\cdot p\cdot(1-p)\big{)}^{n/2}\Big{)}\geq\frac{1}{T-1},blackboard_P ( italic_X start_POSTSUPERSCRIPT ( 0 ) end_POSTSUPERSCRIPT ≥ italic_n / 2 ) ≥ divide start_ARG 1 end_ARG start_ARG square-root start_ARG 2 italic_n end_ARG end_ARG ⋅ ( ( 4 ⋅ italic_p ⋅ ( 1 - italic_p ) ) start_POSTSUPERSCRIPT italic_n / 2 end_POSTSUPERSCRIPT ) ≥ divide start_ARG 1 end_ARG start_ARG italic_T - 1 end_ARG , (\arabicequation)

which is equivalent to

p(1p)14((2n)1/2T1)2/n.𝑝1𝑝14superscriptsuperscript2𝑛12𝑇12𝑛p\cdot(1-p)\geq\frac{1}{4}\cdot\Big{(}\frac{(2n)^{1/2}}{T-1}\Big{)}^{2/n}.italic_p ⋅ ( 1 - italic_p ) ≥ divide start_ARG 1 end_ARG start_ARG 4 end_ARG ⋅ ( divide start_ARG ( 2 italic_n ) start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT end_ARG start_ARG italic_T - 1 end_ARG ) start_POSTSUPERSCRIPT 2 / italic_n end_POSTSUPERSCRIPT . (\arabicequation)

Observe that if we assume that p1/2𝑝12p\leq 1/2italic_p ≤ 1 / 2, then a value of p𝑝pitalic_p that satisfies

p214((2n)1/2T1)2/np12((2n)1/2T1)1/nformulae-sequencesuperscript𝑝214superscriptsuperscript2𝑛12𝑇12𝑛iff𝑝12superscriptsuperscript2𝑛12𝑇11𝑛p^{2}\geq\frac{1}{4}\cdot\Big{(}\frac{(2n)^{1/2}}{T-1}\Big{)}^{2/n}\quad\iff% \quad p\geq\frac{1}{2}\cdot\Big{(}\frac{(2n)^{1/2}}{T-1}\Big{)}^{1/n}italic_p start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT ≥ divide start_ARG 1 end_ARG start_ARG 4 end_ARG ⋅ ( divide start_ARG ( 2 italic_n ) start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT end_ARG start_ARG italic_T - 1 end_ARG ) start_POSTSUPERSCRIPT 2 / italic_n end_POSTSUPERSCRIPT ⇔ italic_p ≥ divide start_ARG 1 end_ARG start_ARG 2 end_ARG ⋅ ( divide start_ARG ( 2 italic_n ) start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT end_ARG start_ARG italic_T - 1 end_ARG ) start_POSTSUPERSCRIPT 1 / italic_n end_POSTSUPERSCRIPT (\arabicequation)

is ensured to satisfy (\arabicequation).

This means if 1/2((2n)1/2/(T1))1/np1/2normal-⋅12superscriptsuperscript2𝑛12𝑇11𝑛𝑝121/2\cdot((2n)^{1/2}/(T-1))^{1/n}\leq p\leq 1/21 / 2 ⋅ ( ( 2 italic_n ) start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT / ( italic_T - 1 ) ) start_POSTSUPERSCRIPT 1 / italic_n end_POSTSUPERSCRIPT ≤ italic_p ≤ 1 / 2, then there is at least probability 1/(T1)1𝑇11/(T-1)1 / ( italic_T - 1 ) that X(1/T)n/2superscript𝑋1𝑇𝑛2X^{(1/T)}\geq n/2italic_X start_POSTSUPERSCRIPT ( 1 / italic_T ) end_POSTSUPERSCRIPT ≥ italic_n / 2. Therefore, using this value of p𝑝pitalic_p, we infer from (\arabicequation) that

[1(X(1/T)n/2)]T1(11T1)T1(i)1/e0.37,superscriptdelimited-[]1superscript𝑋1𝑇𝑛2𝑇1superscript11𝑇1𝑇1𝑖1𝑒0.37\Big{[}1-\mathbb{P}\Big{(}X^{(1/T)}\geq n/2\Big{)}\Big{]}^{T-1}\leq\big{(}1-% \frac{1}{T-1}\big{)}^{T-1}\overset{(i)}{\leq}1/e\approx 0.37,[ 1 - blackboard_P ( italic_X start_POSTSUPERSCRIPT ( 1 / italic_T ) end_POSTSUPERSCRIPT ≥ italic_n / 2 ) ] start_POSTSUPERSCRIPT italic_T - 1 end_POSTSUPERSCRIPT ≤ ( 1 - divide start_ARG 1 end_ARG start_ARG italic_T - 1 end_ARG ) start_POSTSUPERSCRIPT italic_T - 1 end_POSTSUPERSCRIPT start_OVERACCENT ( italic_i ) end_OVERACCENT start_ARG ≤ end_ARG 1 / italic_e ≈ 0.37 , (\arabicequation)

where (i)𝑖(i)( italic_i ) uses limx(11/x)x=1/esubscriptnormal-→𝑥superscript11𝑥𝑥1𝑒\lim_{x\rightarrow\infty}(1-1/x)^{x}=1/eroman_lim start_POSTSUBSCRIPT italic_x → ∞ end_POSTSUBSCRIPT ( 1 - 1 / italic_x ) start_POSTSUPERSCRIPT italic_x end_POSTSUPERSCRIPT = 1 / italic_e from below. Plugging (\arabicequation) back into (\arabicequation) shows for probability p𝑝pitalic_p that a node changes membership within any time interval of length 1/T1𝑇1/T1 / italic_T, then for any T2𝑇2T\geq 2italic_T ≥ 2,

(X(t)n/2, for some t{1/T,,(T1)/T})11/e0.63.formulae-sequencesuperscript𝑋𝑡𝑛2 for some 𝑡1𝑇𝑇1𝑇11𝑒0.63\mathbb{P}\Big{(}X^{(t)}\geq n/2,\text{ for some }t\in\{1/T,\ldots,(T-1)/T\}% \Big{)}\geq 1-1/e\approx 0.63.blackboard_P ( italic_X start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ≥ italic_n / 2 , for some italic_t ∈ { 1 / italic_T , … , ( italic_T - 1 ) / italic_T } ) ≥ 1 - 1 / italic_e ≈ 0.63 .

Lastly, we are now interested in the relation between γ𝛾\gammaitalic_γ and T𝑇Titalic_T such that there is at least a probability p𝑝pitalic_p of a node changing memberships in a time interval of length 1/T1𝑇1/T1 / italic_T. By the Poisson process in Assumption \arabicsection.\arabicsubsection, the probability a node changes membership in such an interval is

1exp(γ/T)1𝛾𝑇\displaystyle 1-\exp(-\gamma/T)1 - roman_exp ( - italic_γ / italic_T ) p=12((2n)1/2T1)1/nabsent𝑝12superscriptsuperscript2𝑛12𝑇11𝑛\displaystyle\geq p=\frac{1}{2}\cdot\Big{(}\frac{(2n)^{1/2}}{T-1}\Big{)}^{1/n}≥ italic_p = divide start_ARG 1 end_ARG start_ARG 2 end_ARG ⋅ ( divide start_ARG ( 2 italic_n ) start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT end_ARG start_ARG italic_T - 1 end_ARG ) start_POSTSUPERSCRIPT 1 / italic_n end_POSTSUPERSCRIPT
γ𝛾\displaystyle\Longrightarrow\quad\gamma⟹ italic_γ Tlog[(112((2n)1/2T1)1/n)1]absent𝑇superscript112superscriptsuperscript2𝑛12𝑇11𝑛1\displaystyle\geq T\cdot\log\bigg{[}\bigg{(}1-\frac{1}{2}\cdot\Big{(}\frac{(2n% )^{1/2}}{T-1}\Big{)}^{1/n}\bigg{)}^{-1}\bigg{]}≥ italic_T ⋅ roman_log [ ( 1 - divide start_ARG 1 end_ARG start_ARG 2 end_ARG ⋅ ( divide start_ARG ( 2 italic_n ) start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT end_ARG start_ARG italic_T - 1 end_ARG ) start_POSTSUPERSCRIPT 1 / italic_n end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT - 1 end_POSTSUPERSCRIPT ]

Hence, we are done.

Proof of Proposition \arabicsection.\arabictheorem.

Proof .\arabictheorem.

Consider a particular time t𝒯\{1}𝑡normal-\𝒯1t\in\mathcal{T}\backslash\{1\}italic_t ∈ caligraphic_T \ { 1 }. For any time t𝑡titalic_t and t+1/T𝑡1𝑇t+1/Titalic_t + 1 / italic_T, consider the confusion matrix C(t,t+1/T)superscript𝐶𝑡𝑡1𝑇C^{(t,t+1/T)}italic_C start_POSTSUPERSCRIPT ( italic_t , italic_t + 1 / italic_T ) end_POSTSUPERSCRIPT formed between membership matrices M(t)superscript𝑀𝑡M^{(t)}italic_M start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT and M(t+1/T)superscript𝑀𝑡1𝑇M^{(t+1/T)}italic_M start_POSTSUPERSCRIPT ( italic_t + 1 / italic_T ) end_POSTSUPERSCRIPT. Let C=C(t,t+1/T)𝐶superscript𝐶𝑡𝑡1𝑇C=C^{(t,t+1/T)}italic_C = italic_C start_POSTSUPERSCRIPT ( italic_t , italic_t + 1 / italic_T ) end_POSTSUPERSCRIPT for notational simplicity. Let mminsubscript𝑚m_{\min}italic_m start_POSTSUBSCRIPT roman_min end_POSTSUBSCRIPT denote the size of the smallest community at time t𝑡titalic_t,

mmin=mink{1,,K}i=1nMik(t)=mink{1,,K}=1KCk.subscript𝑚subscript𝑘1𝐾superscriptsubscript𝑖1𝑛superscriptsubscript𝑀𝑖𝑘𝑡subscript𝑘1𝐾superscriptsubscript1𝐾subscript𝐶𝑘m_{\min}=\min_{k\in\{1,\ldots,K\}}\sum_{i=1}^{n}M_{ik}^{(t)}=\min_{k\in\{1,% \ldots,K\}}\sum_{\ell=1}^{K}C_{k\ell}.italic_m start_POSTSUBSCRIPT roman_min end_POSTSUBSCRIPT = roman_min start_POSTSUBSCRIPT italic_k ∈ { 1 , … , italic_K } end_POSTSUBSCRIPT ∑ start_POSTSUBSCRIPT italic_i = 1 end_POSTSUBSCRIPT start_POSTSUPERSCRIPT italic_n end_POSTSUPERSCRIPT italic_M start_POSTSUBSCRIPT italic_i italic_k end_POSTSUBSCRIPT start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT = roman_min start_POSTSUBSCRIPT italic_k ∈ { 1 , … , italic_K } end_POSTSUBSCRIPT ∑ start_POSTSUBSCRIPT roman_ℓ = 1 end_POSTSUBSCRIPT start_POSTSUPERSCRIPT italic_K end_POSTSUPERSCRIPT italic_C start_POSTSUBSCRIPT italic_k roman_ℓ end_POSTSUBSCRIPT .

Consider any community k{1,,K}𝑘1normal-…𝐾k\in\{1,\ldots,K\}italic_k ∈ { 1 , … , italic_K }. We first compare Ckksubscript𝐶𝑘𝑘C_{kk}italic_C start_POSTSUBSCRIPT italic_k italic_k end_POSTSUBSCRIPT to the sum of all the other elements in the row (i.e., the number of nodes that leave community k𝑘kitalic_k between time t𝑡titalic_t and t+1/T𝑡1𝑇t+1/Titalic_t + 1 / italic_T). Let z=:kCk𝑧subscriptnormal-:normal-ℓ𝑘normal-ℓsubscript𝐶𝑘normal-ℓz=\sum_{\ell:k\neq\ell}C_{k\ell}italic_z = ∑ start_POSTSUBSCRIPT roman_ℓ : italic_k ≠ roman_ℓ end_POSTSUBSCRIPT italic_C start_POSTSUBSCRIPT italic_k roman_ℓ end_POSTSUBSCRIPT. Since Ckk+zsubscript𝐶𝑘𝑘𝑧C_{kk}+zitalic_C start_POSTSUBSCRIPT italic_k italic_k end_POSTSUBSCRIPT + italic_z equals the number of nodes in community k𝑘kitalic_k at time t𝑡titalic_t, and that the number of nodes that change is at most mmin/2subscript𝑚2m_{\min}/2italic_m start_POSTSUBSCRIPT roman_min end_POSTSUBSCRIPT / 2, we know

mminCkk+z𝑎𝑛𝑑zmmin/2Ckkz.formulae-sequencesubscript𝑚subscript𝐶𝑘𝑘𝑧𝑎𝑛𝑑formulae-sequence𝑧subscript𝑚2subscript𝐶𝑘𝑘𝑧m_{\min}\leq C_{kk}+z\quad\text{and}\quad z\leq m_{\min}/2\quad\Rightarrow% \quad C_{kk}\geq z.italic_m start_POSTSUBSCRIPT roman_min end_POSTSUBSCRIPT ≤ italic_C start_POSTSUBSCRIPT italic_k italic_k end_POSTSUBSCRIPT + italic_z and italic_z ≤ italic_m start_POSTSUBSCRIPT roman_min end_POSTSUBSCRIPT / 2 ⇒ italic_C start_POSTSUBSCRIPT italic_k italic_k end_POSTSUBSCRIPT ≥ italic_z .

Next, we compare Ckksubscript𝐶𝑘𝑘C_{kk}italic_C start_POSTSUBSCRIPT italic_k italic_k end_POSTSUBSCRIPT to the sum of all the other elements in the column (i.e., the number of nodes that enter community k𝑘kitalic_k between time t𝑡titalic_t and t+1/T𝑡1𝑇t+1/Titalic_t + 1 / italic_T). Let y=:kCk𝑦subscriptnormal-:normal-ℓ𝑘normal-ℓsubscript𝐶normal-ℓ𝑘y=\sum_{\ell:k\neq\ell}C_{\ell k}italic_y = ∑ start_POSTSUBSCRIPT roman_ℓ : italic_k ≠ roman_ℓ end_POSTSUBSCRIPT italic_C start_POSTSUBSCRIPT roman_ℓ italic_k end_POSTSUBSCRIPT. Since Ckk+zsubscript𝐶𝑘𝑘𝑧C_{kk}+zitalic_C start_POSTSUBSCRIPT italic_k italic_k end_POSTSUBSCRIPT + italic_z equals the number of nodes in community k𝑘kitalic_k at time t𝑡titalic_t, and the number of nodes that change total is less than mmin/2subscript𝑚2m_{\min}/2italic_m start_POSTSUBSCRIPT roman_min end_POSTSUBSCRIPT / 2, we know

mminCkk+z𝑎𝑛𝑑z+ymmin/2Ckkmmin/2+yy,formulae-sequencesubscript𝑚subscript𝐶𝑘𝑘𝑧𝑎𝑛𝑑formulae-sequence𝑧𝑦subscript𝑚2subscript𝐶𝑘𝑘subscript𝑚2𝑦𝑦m_{\min}\leq C_{kk}+z\quad\text{and}\quad z+y\leq m_{\min}/2\quad\Rightarrow% \quad C_{kk}\geq m_{\min}/2+y\geq y,italic_m start_POSTSUBSCRIPT roman_min end_POSTSUBSCRIPT ≤ italic_C start_POSTSUBSCRIPT italic_k italic_k end_POSTSUBSCRIPT + italic_z and italic_z + italic_y ≤ italic_m start_POSTSUBSCRIPT roman_min end_POSTSUBSCRIPT / 2 ⇒ italic_C start_POSTSUBSCRIPT italic_k italic_k end_POSTSUBSCRIPT ≥ italic_m start_POSTSUBSCRIPT roman_min end_POSTSUBSCRIPT / 2 + italic_y ≥ italic_y ,

which completes the proof.

Note that the above proof works for any number of communities, not necessarily only when K=2𝐾2K=2italic_K = 2.

Proof of Proposition \arabicsection.\arabictheorem.

Proof .\arabictheorem.

Let x(t)=M(t)M(t+1/T)0superscript𝑥𝑡subscriptnormsuperscript𝑀𝑡superscript𝑀𝑡1𝑇0x^{(t)}=\|M^{(t)}-M^{(t+1/T)}\|_{0}italic_x start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT = ∥ italic_M start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT - italic_M start_POSTSUPERSCRIPT ( italic_t + 1 / italic_T ) end_POSTSUPERSCRIPT ∥ start_POSTSUBSCRIPT 0 end_POSTSUBSCRIPT and y(t)=mink{1,,K}i=1nMik(t)superscript𝑦𝑡subscript𝑘1normal-…𝐾superscriptsubscript𝑖1𝑛subscriptsuperscript𝑀𝑡𝑖𝑘y^{(t)}=\min_{k\in\{1,\ldots,K\}}\sum_{i=1}^{n}M^{(t)}_{ik}italic_y start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT = roman_min start_POSTSUBSCRIPT italic_k ∈ { 1 , … , italic_K } end_POSTSUBSCRIPT ∑ start_POSTSUBSCRIPT italic_i = 1 end_POSTSUBSCRIPT start_POSTSUPERSCRIPT italic_n end_POSTSUPERSCRIPT italic_M start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT start_POSTSUBSCRIPT italic_i italic_k end_POSTSUBSCRIPT. Observe that we have the following relation in events,

{x(t)y(t),for some time t𝒯}{x(t)Δ,for some time t𝒯}1{Δy(t),for some time t𝒯}2.formulae-sequencesuperscript𝑥𝑡superscript𝑦𝑡for some time 𝑡𝒯subscriptformulae-sequencesuperscript𝑥𝑡Δfor some time 𝑡𝒯subscript1subscriptformulae-sequenceΔsuperscript𝑦𝑡for some time 𝑡𝒯subscript2\Big{\{}x^{(t)}\geq y^{(t)},\;\;\text{for some time }t\in\mathcal{T}\Big{\}}% \Longrightarrow\underbrace{\Big{\{}x^{(t)}\geq\Delta,\;\;\text{for some time }% t\in\mathcal{T}\Big{\}}}_{\mathcal{E}_{1}}\cup\underbrace{\Big{\{}\Delta\geq y% ^{(t)},\;\;\text{for some time }t\in\mathcal{T}\Big{\}}}_{\mathcal{E}_{2}}.{ italic_x start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ≥ italic_y start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT , for some time italic_t ∈ caligraphic_T } ⟹ under⏟ start_ARG { italic_x start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ≥ roman_Δ , for some time italic_t ∈ caligraphic_T } end_ARG start_POSTSUBSCRIPT caligraphic_E start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT end_POSTSUBSCRIPT ∪ under⏟ start_ARG { roman_Δ ≥ italic_y start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT , for some time italic_t ∈ caligraphic_T } end_ARG start_POSTSUBSCRIPT caligraphic_E start_POSTSUBSCRIPT 2 end_POSTSUBSCRIPT end_POSTSUBSCRIPT .

for any constant Δ>0normal-Δ0\Delta>0roman_Δ > 0. Hence, we wish to upper-bound the following undesirable event via a union bound,

(x(t)y(t),for some time t𝒯)(1)+(2).formulae-sequencesuperscript𝑥𝑡superscript𝑦𝑡for some time 𝑡𝒯subscript1subscript2\mathbb{P}\Big{(}x^{(t)}\geq y^{(t)},\;\;\text{for some time }t\in\mathcal{T}% \Big{)}\leq\mathbb{P}\big{(}\mathcal{E}_{1}\big{)}+\mathbb{P}\big{(}\mathcal{E% }_{2}\big{)}.blackboard_P ( italic_x start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ≥ italic_y start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT , for some time italic_t ∈ caligraphic_T ) ≤ blackboard_P ( caligraphic_E start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT ) + blackboard_P ( caligraphic_E start_POSTSUBSCRIPT 2 end_POSTSUBSCRIPT ) . (\arabicequation)

We invoke Lemma .\arabictheorem to first upper-bound (2)subscript2\mathbb{P}(\mathcal{E}_{2})blackboard_P ( caligraphic_E start_POSTSUBSCRIPT 2 end_POSTSUBSCRIPT ) by 1/T1𝑇1/T1 / italic_T via a recursive decomposition and to pick the appropriate threshold Δnormal-Δ\Deltaroman_Δ, specifically,

Δ=n2cmax{nγlog(T),log(T)}Δ𝑛2𝑐𝑛𝛾𝑇𝑇\Delta=\frac{n}{2}-c\cdot\max\big{\{}\sqrt{n\gamma\log(T)},\log(T)\big{\}}roman_Δ = divide start_ARG italic_n end_ARG start_ARG 2 end_ARG - italic_c ⋅ roman_max { square-root start_ARG italic_n italic_γ roman_log ( italic_T ) end_ARG , roman_log ( italic_T ) }

for some universal constant c𝑐citalic_c. (By Assumption \arabicsection.\arabicsubsection and γ/T=o(1)𝛾𝑇𝑜1\gamma/T=o(1)italic_γ / italic_T = italic_o ( 1 ), we are assured that max{nγlog(T),log(T)}nmuch-less-than𝑛𝛾𝑇𝑇𝑛\max\{\sqrt{n\gamma\log(T)},\log(T)\}\ll nroman_max { square-root start_ARG italic_n italic_γ roman_log ( italic_T ) end_ARG , roman_log ( italic_T ) } ≪ italic_n.) Using this threshold Δnormal-Δ\Deltaroman_Δ, we then invoke Lemma .\arabictheorem which shows that

(x(t)>5nγT+4log(T))1/T2,for a particular time t𝒯.formulae-sequencesuperscript𝑥𝑡5𝑛𝛾𝑇4𝑇1superscript𝑇2for a particular time 𝑡𝒯\mathbb{P}\Big{(}x^{(t)}>\frac{5n\gamma}{T}+4\log(T)\Big{)}\leq 1/T^{2},\quad% \text{for a particular time }t\in\mathcal{T}.blackboard_P ( italic_x start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT > divide start_ARG 5 italic_n italic_γ end_ARG start_ARG italic_T end_ARG + 4 roman_log ( italic_T ) ) ≤ 1 / italic_T start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT , for a particular time italic_t ∈ caligraphic_T .

Since Assumption \arabicsection.\arabicsubsection and γ/T=o(1)𝛾𝑇𝑜1\gamma/T=o(1)italic_γ / italic_T = italic_o ( 1 ) ensure that 5nγ/T+4log(T)Δmuch-less-than5𝑛𝛾𝑇4𝑇normal-Δ5n\gamma/T+4\log(T)\ll\Delta5 italic_n italic_γ / italic_T + 4 roman_log ( italic_T ) ≪ roman_Δ, we have upper-bound shown (1)<1/Tsubscript11𝑇\mathbb{P}(\mathcal{E}_{1})<1/Tblackboard_P ( caligraphic_E start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT ) < 1 / italic_T via a union bound. Therefore, altogether, we obtain the desired upper-bound when plugging these bounds into (\arabicequation),

(M(t)M(t+1/T)0mink{1,,K}i=1nMik(t), for some time t𝒯)2T,formulae-sequencesubscriptnormsuperscript𝑀𝑡superscript𝑀𝑡1𝑇0subscript𝑘1𝐾superscriptsubscript𝑖1𝑛superscriptsubscript𝑀𝑖𝑘𝑡 for some time 𝑡𝒯2𝑇\mathbb{P}\Big{(}\big{\|}M^{(t)}-M^{(t+1/T)}\big{\|}_{0}\geq\min_{k\in\{1,% \ldots,K\}}\sum_{i=1}^{n}M_{ik}^{(t)},\text{ for some time }t\in\mathcal{T}% \Big{)}\leq\frac{2}{T},blackboard_P ( ∥ italic_M start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT - italic_M start_POSTSUPERSCRIPT ( italic_t + 1 / italic_T ) end_POSTSUPERSCRIPT ∥ start_POSTSUBSCRIPT 0 end_POSTSUBSCRIPT ≥ roman_min start_POSTSUBSCRIPT italic_k ∈ { 1 , … , italic_K } end_POSTSUBSCRIPT ∑ start_POSTSUBSCRIPT italic_i = 1 end_POSTSUBSCRIPT start_POSTSUPERSCRIPT italic_n end_POSTSUPERSCRIPT italic_M start_POSTSUBSCRIPT italic_i italic_k end_POSTSUBSCRIPT start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT , for some time italic_t ∈ caligraphic_T ) ≤ divide start_ARG 2 end_ARG start_ARG italic_T end_ARG ,

or equivalently,

(M(t)M(t+1/T)0<mink{1,,K}i=1nMik(t), for all time t𝒯)12T,formulae-sequencesubscriptnormsuperscript𝑀𝑡superscript𝑀𝑡1𝑇0subscript𝑘1𝐾superscriptsubscript𝑖1𝑛superscriptsubscript𝑀𝑖𝑘𝑡 for all time 𝑡𝒯12𝑇\mathbb{P}\Big{(}\big{\|}M^{(t)}-M^{(t+1/T)}\big{\|}_{0}<\min_{k\in\{1,\ldots,% K\}}\sum_{i=1}^{n}M_{ik}^{(t)},\text{ for all time }t\in\mathcal{T}\Big{)}\geq 1% -\frac{2}{T},blackboard_P ( ∥ italic_M start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT - italic_M start_POSTSUPERSCRIPT ( italic_t + 1 / italic_T ) end_POSTSUPERSCRIPT ∥ start_POSTSUBSCRIPT 0 end_POSTSUBSCRIPT < roman_min start_POSTSUBSCRIPT italic_k ∈ { 1 , … , italic_K } end_POSTSUBSCRIPT ∑ start_POSTSUBSCRIPT italic_i = 1 end_POSTSUBSCRIPT start_POSTSUPERSCRIPT italic_n end_POSTSUPERSCRIPT italic_M start_POSTSUBSCRIPT italic_i italic_k end_POSTSUBSCRIPT start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT , for all time italic_t ∈ caligraphic_T ) ≥ 1 - divide start_ARG 2 end_ARG start_ARG italic_T end_ARG ,

and complete the proof.

Helper lemmata

We aim to probabilistically bound the relative Hamming distance between two membership matrices given the dynamics stated in Section \arabicsection.

Lemma .\arabictheorem.

Given the model in Section \arabicsection, consider a particular t,r[0,1]𝑡𝑟01t,r\in[0,1]italic_t , italic_r ∈ [ 0 , 1 ]. Letting δ=min{t+r,1}max{tr,0}𝛿𝑡𝑟1𝑡𝑟0\delta=\min\{t+r,1\}-\max\{t-r,0\}italic_δ = roman_min { italic_t + italic_r , 1 } - roman_max { italic_t - italic_r , 0 }, then

(maxs𝒮(t;r)L(M(s),M(t))4γδ+3log(n)n)1nsubscript𝑠𝒮𝑡𝑟𝐿superscript𝑀𝑠superscript𝑀𝑡4𝛾𝛿3𝑛𝑛1𝑛\mathbb{P}\Big{(}\max_{s\in\mathcal{S}(t;r)}L\big{(}M^{(s)},M^{(t)}\big{)}\geq 4% \gamma\delta+\frac{3\log(n)}{n}\Big{)}\leq\frac{1}{n}blackboard_P ( roman_max start_POSTSUBSCRIPT italic_s ∈ caligraphic_S ( italic_t ; italic_r ) end_POSTSUBSCRIPT italic_L ( italic_M start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT , italic_M start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ) ≥ 4 italic_γ italic_δ + divide start_ARG 3 roman_log ( italic_n ) end_ARG start_ARG italic_n end_ARG ) ≤ divide start_ARG 1 end_ARG start_ARG italic_n end_ARG (\arabicequation)

for some universal constant c𝑐citalic_c.

Proof .\arabictheorem.

Let t=min𝒮(t;r)subscript𝑡𝒮𝑡𝑟t_{-}=\min\mathcal{S}(t;r)italic_t start_POSTSUBSCRIPT - end_POSTSUBSCRIPT = roman_min caligraphic_S ( italic_t ; italic_r ), t+=max𝒮(t;r)subscript𝑡𝒮𝑡𝑟t_{+}=\max\mathcal{S}(t;r)italic_t start_POSTSUBSCRIPT + end_POSTSUBSCRIPT = roman_max caligraphic_S ( italic_t ; italic_r ) and choose any t,t′′𝒮(t;r)superscript𝑡normal-′superscript𝑡normal-′′𝒮𝑡𝑟t^{\prime},t^{\prime\prime}\in\mathcal{S}(t;r)italic_t start_POSTSUPERSCRIPT ′ end_POSTSUPERSCRIPT , italic_t start_POSTSUPERSCRIPT ′ ′ end_POSTSUPERSCRIPT ∈ caligraphic_S ( italic_t ; italic_r ) where 0ttt′′t+10subscript𝑡superscript𝑡normal-′superscript𝑡normal-′′subscript𝑡10\leq t_{-}\leq t^{\prime}\leq t^{\prime\prime}\leq t_{+}\leq 10 ≤ italic_t start_POSTSUBSCRIPT - end_POSTSUBSCRIPT ≤ italic_t start_POSTSUPERSCRIPT ′ end_POSTSUPERSCRIPT ≤ italic_t start_POSTSUPERSCRIPT ′ ′ end_POSTSUPERSCRIPT ≤ italic_t start_POSTSUBSCRIPT + end_POSTSUBSCRIPT ≤ 1. For an τ>0𝜏0\tau>0italic_τ > 0 to be determined, consider the four events,

1subscript1\displaystyle\mathcal{E}_{1}caligraphic_E start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT ={nL(M(t),M(t′′))nγδ+τ},absent𝑛𝐿superscript𝑀superscript𝑡superscript𝑀superscript𝑡′′𝑛𝛾𝛿𝜏\displaystyle=\Big{\{}n\cdot L(M^{(t^{\prime})},M^{(t^{\prime\prime})})\geq n% \gamma\delta+\tau\Big{\}},= { italic_n ⋅ italic_L ( italic_M start_POSTSUPERSCRIPT ( italic_t start_POSTSUPERSCRIPT ′ end_POSTSUPERSCRIPT ) end_POSTSUPERSCRIPT , italic_M start_POSTSUPERSCRIPT ( italic_t start_POSTSUPERSCRIPT ′ ′ end_POSTSUPERSCRIPT ) end_POSTSUPERSCRIPT ) ≥ italic_n italic_γ italic_δ + italic_τ } ,
2subscript2\displaystyle\mathcal{E}_{2}caligraphic_E start_POSTSUBSCRIPT 2 end_POSTSUBSCRIPT ={(# of nodes that changed communities anytime between t and t′′)nγδ+τ},absent# of nodes that changed communities anytime between superscript𝑡 and superscript𝑡′′𝑛𝛾𝛿𝜏\displaystyle=\Big{\{}\big{(}\text{\# of nodes that changed communities % anytime between }t^{\prime}\text{ and }t^{\prime\prime}\big{)}\geq n\gamma% \delta+\tau\Big{\}},= { ( # of nodes that changed communities anytime between italic_t start_POSTSUPERSCRIPT ′ end_POSTSUPERSCRIPT and italic_t start_POSTSUPERSCRIPT ′ ′ end_POSTSUPERSCRIPT ) ≥ italic_n italic_γ italic_δ + italic_τ } ,
3subscript3\displaystyle\mathcal{E}_{3}caligraphic_E start_POSTSUBSCRIPT 3 end_POSTSUBSCRIPT ={(# of nodes that changed communities anytime between t and t+)nγδ+τ},absent# of nodes that changed communities anytime between subscript𝑡 and subscript𝑡𝑛𝛾𝛿𝜏\displaystyle=\Big{\{}\big{(}\text{\# of nodes that changed communities % anytime between }t_{-}\text{ and }t_{+}\big{)}\geq n\gamma\delta+\tau\Big{\}},= { ( # of nodes that changed communities anytime between italic_t start_POSTSUBSCRIPT - end_POSTSUBSCRIPT and italic_t start_POSTSUBSCRIPT + end_POSTSUBSCRIPT ) ≥ italic_n italic_γ italic_δ + italic_τ } ,
4subscript4\displaystyle\mathcal{E}_{4}caligraphic_E start_POSTSUBSCRIPT 4 end_POSTSUBSCRIPT ={s=tt+nL(M(s),M(s+1/T))nγδ+τ}.absentsuperscriptsubscript𝑠subscript𝑡subscript𝑡𝑛𝐿superscript𝑀𝑠superscript𝑀𝑠1𝑇𝑛𝛾𝛿𝜏\displaystyle=\Big{\{}\sum_{s=t_{-}}^{t_{+}}n\cdot L(M^{(s)},M^{(s+1/T)})\geq n% \gamma\delta+\tau\Big{\}}.= { ∑ start_POSTSUBSCRIPT italic_s = italic_t start_POSTSUBSCRIPT - end_POSTSUBSCRIPT end_POSTSUBSCRIPT start_POSTSUPERSCRIPT italic_t start_POSTSUBSCRIPT + end_POSTSUBSCRIPT end_POSTSUPERSCRIPT italic_n ⋅ italic_L ( italic_M start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT , italic_M start_POSTSUPERSCRIPT ( italic_s + 1 / italic_T ) end_POSTSUPERSCRIPT ) ≥ italic_n italic_γ italic_δ + italic_τ } .

Observe that for simultaneously over such choice of tsuperscript𝑡normal-′t^{\prime}italic_t start_POSTSUPERSCRIPT ′ end_POSTSUPERSCRIPT and t′′superscript𝑡normal-′′t^{\prime\prime}italic_t start_POSTSUPERSCRIPT ′ ′ end_POSTSUPERSCRIPT, 1234normal-⇒subscript1subscript2normal-⇒subscript3normal-⇒subscript4\mathcal{E}_{1}\Rightarrow\mathcal{E}_{2}\Rightarrow\mathcal{E}_{3}\Rightarrow% \mathcal{E}_{4}caligraphic_E start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT ⇒ caligraphic_E start_POSTSUBSCRIPT 2 end_POSTSUBSCRIPT ⇒ caligraphic_E start_POSTSUBSCRIPT 3 end_POSTSUBSCRIPT ⇒ caligraphic_E start_POSTSUBSCRIPT 4 end_POSTSUBSCRIPT, where the last event models the number of nodes that change communities between any two consecutive timepoints in 𝒮(t;r)𝒮𝑡𝑟\mathcal{S}(t;r)caligraphic_S ( italic_t ; italic_r ). Hence (1)(4)subscript1subscript4\mathbb{P}(\mathcal{E}_{1})\leq\mathbb{P}(\mathcal{E}_{4})blackboard_P ( caligraphic_E start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT ) ≤ blackboard_P ( caligraphic_E start_POSTSUBSCRIPT 4 end_POSTSUBSCRIPT ), which implies that

(maxs𝒮(t;r)L(M(s),M(t))γδ+τ/n)(4).subscript𝑠𝒮𝑡𝑟𝐿superscript𝑀𝑠superscript𝑀𝑡𝛾𝛿𝜏𝑛subscript4\mathbb{P}\Big{(}\max_{s\in\mathcal{S}(t;r)}L\big{(}M^{(s)},M^{(t)}\big{)}\geq% \gamma\delta+\tau/n\Big{)}\leq\mathbb{P}\big{(}\mathcal{E}_{4}\big{)}.blackboard_P ( roman_max start_POSTSUBSCRIPT italic_s ∈ caligraphic_S ( italic_t ; italic_r ) end_POSTSUBSCRIPT italic_L ( italic_M start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT , italic_M start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ) ≥ italic_γ italic_δ + italic_τ / italic_n ) ≤ blackboard_P ( caligraphic_E start_POSTSUBSCRIPT 4 end_POSTSUBSCRIPT ) . (\arabicequation)

Hence, we focus on the upper-bounding the RHS.

Let T~=|𝒮(t;r)|=δTnormal-~𝑇𝒮𝑡𝑟normal-⋅𝛿𝑇\widetilde{T}=|\mathcal{S}(t;r)|=\delta\cdot Tover~ start_ARG italic_T end_ARG = | caligraphic_S ( italic_t ; italic_r ) | = italic_δ ⋅ italic_T, i.e., the number of summands in the summation on the LHS of 4subscript4\mathcal{E}_{4}caligraphic_E start_POSTSUBSCRIPT 4 end_POSTSUBSCRIPT. This is also the number of non-overlap** intervals of length 1/T1𝑇1/T1 / italic_T (plus one) that fit between tsubscript𝑡t_{-}italic_t start_POSTSUBSCRIPT - end_POSTSUBSCRIPT and t+subscript𝑡t_{+}italic_t start_POSTSUBSCRIPT + end_POSTSUBSCRIPT. Observe that since the nodes change communities according to a Poisson(γ𝛾\gammaitalic_γ) process independently of one another, the probability a node changes communities in a time interval of 1/T1𝑇1/T1 / italic_T is 1exp(γ/T)1𝛾𝑇1-\exp(-\gamma/T)1 - roman_exp ( - italic_γ / italic_T ). Consider two Binomial random variables X𝑋Xitalic_X and Y𝑌Yitalic_Y defined as

X𝑋\displaystyle Xitalic_X 𝐵𝑒𝑟𝑛𝑜𝑢𝑙𝑙𝑖(nT~, 1exp(γ/T))similar-toabsent𝐵𝑒𝑟𝑛𝑜𝑢𝑙𝑙𝑖𝑛~𝑇1𝛾𝑇\displaystyle\sim\text{Bernoulli}\big{(}n\cdot\widetilde{T},\;1-\exp(-\gamma/T% )\big{)}∼ Bernoulli ( italic_n ⋅ over~ start_ARG italic_T end_ARG , 1 - roman_exp ( - italic_γ / italic_T ) )
Y𝑌\displaystyle Yitalic_Y 𝐵𝑒𝑟𝑛𝑜𝑢𝑙𝑙𝑖(nT~,max{γ/T,1}),similar-toabsent𝐵𝑒𝑟𝑛𝑜𝑢𝑙𝑙𝑖𝑛~𝑇𝛾𝑇1\displaystyle\sim\text{Bernoulli}\big{(}n\cdot\widetilde{T},\;\max\big{\{}% \gamma/T,1\big{\}}\big{)},∼ Bernoulli ( italic_n ⋅ over~ start_ARG italic_T end_ARG , roman_max { italic_γ / italic_T , 1 } ) ,

which represents the number of success among nT~normal-⋅𝑛normal-~𝑇n\cdot\widetilde{T}italic_n ⋅ over~ start_ARG italic_T end_ARG trials each with a probability 1exp(γ/T)1𝛾𝑇1-\exp(-\gamma/T)1 - roman_exp ( - italic_γ / italic_T ) or {γ/T,1}𝛾𝑇1\{\gamma/T,1\}{ italic_γ / italic_T , 1 } of success respectively. (Here, a “success” represents a node changing communities within a time interval of length 1/T1𝑇1/T1 / italic_T.) Recalling that exp(x)1x𝑥1𝑥\exp(-x)\geq 1-xroman_exp ( - italic_x ) ≥ 1 - italic_x and that δ=T~/T𝛿normal-~𝑇𝑇\delta=\widetilde{T}/Titalic_δ = over~ start_ARG italic_T end_ARG / italic_T by definition, observe,

(4)=(Xnγδ+τ)(Ynγδ+τ).subscript4𝑋𝑛𝛾𝛿𝜏𝑌𝑛𝛾𝛿𝜏\mathbb{P}\big{(}\mathcal{E}_{4}\big{)}=\mathbb{P}\big{(}X\geq n\gamma\delta+% \tau\big{)}\leq\mathbb{P}\big{(}Y\geq n\gamma\delta+\tau\big{)}.blackboard_P ( caligraphic_E start_POSTSUBSCRIPT 4 end_POSTSUBSCRIPT ) = blackboard_P ( italic_X ≥ italic_n italic_γ italic_δ + italic_τ ) ≤ blackboard_P ( italic_Y ≥ italic_n italic_γ italic_δ + italic_τ ) . (\arabicequation)

Continuing, kee** in mind that 𝔼[X]𝔼[Y]nγδ𝔼delimited-[]𝑋𝔼delimited-[]𝑌𝑛𝛾𝛿\mathbb{E}[X]\leq\mathbb{E}[Y]\leq n\gamma\deltablackboard_E [ italic_X ] ≤ blackboard_E [ italic_Y ] ≤ italic_n italic_γ italic_δ, we derive\arabicfootnote\arabicfootnote\arabicfootnoteObserve: if γ/T>1𝛾𝑇1\gamma/T>1italic_γ / italic_T > 1, then (Ynγδ+τ)=0𝑌𝑛𝛾𝛿𝜏0\mathbb{P}(Y\geq n\gamma\delta+\tau)=0blackboard_P ( italic_Y ≥ italic_n italic_γ italic_δ + italic_τ ) = 0 since the maximum value of Y𝑌Yitalic_Y is nT~𝑛normal-~𝑇n\widetilde{T}italic_n over~ start_ARG italic_T end_ARG, whereas nγδ=nγT~/T>nT~𝑛𝛾𝛿𝑛𝛾normal-~𝑇𝑇𝑛normal-~𝑇n\gamma\delta=n\gamma\widetilde{T}/T>n\widetilde{T}italic_n italic_γ italic_δ = italic_n italic_γ over~ start_ARG italic_T end_ARG / italic_T > italic_n over~ start_ARG italic_T end_ARG.

(Ynγδ+τ)𝑌𝑛𝛾𝛿𝜏\displaystyle\mathbb{P}\big{(}Y\geq n\gamma\delta+\tau\big{)}blackboard_P ( italic_Y ≥ italic_n italic_γ italic_δ + italic_τ ) (i)exp(12τ2γT(1γT)nT~+13τ)𝑖12superscript𝜏2𝛾𝑇1𝛾𝑇𝑛~𝑇13𝜏\displaystyle\overset{(i)}{\leq}\exp\Big{(}\frac{-\frac{1}{2}\tau^{2}}{\frac{% \gamma}{T}\cdot(1-\frac{\gamma}{T})\cdot n\cdot\widetilde{T}+\frac{1}{3}\tau}% \Big{)}start_OVERACCENT ( italic_i ) end_OVERACCENT start_ARG ≤ end_ARG roman_exp ( divide start_ARG - divide start_ARG 1 end_ARG start_ARG 2 end_ARG italic_τ start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT end_ARG start_ARG divide start_ARG italic_γ end_ARG start_ARG italic_T end_ARG ⋅ ( 1 - divide start_ARG italic_γ end_ARG start_ARG italic_T end_ARG ) ⋅ italic_n ⋅ over~ start_ARG italic_T end_ARG + divide start_ARG 1 end_ARG start_ARG 3 end_ARG italic_τ end_ARG )
exp(12τ2nγδ+13τ)absent12superscript𝜏2𝑛𝛾𝛿13𝜏\displaystyle\leq\exp\Big{(}\frac{-\frac{1}{2}\tau^{2}}{n\gamma\delta+\frac{1}% {3}\tau}\Big{)}≤ roman_exp ( divide start_ARG - divide start_ARG 1 end_ARG start_ARG 2 end_ARG italic_τ start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT end_ARG start_ARG italic_n italic_γ italic_δ + divide start_ARG 1 end_ARG start_ARG 3 end_ARG italic_τ end_ARG ) (\arabicequation)

where (i)𝑖(i)( italic_i ) holds via Bernstein’s inequality (for example, Lemma 4.1.9 from De la Pena & Giné (2012)).

Consider τ=3nγδ+3log(n)𝜏3𝑛𝛾𝛿3𝑛\tau=3n\gamma\delta+3\log(n)italic_τ = 3 italic_n italic_γ italic_δ + 3 roman_log ( italic_n ). If log(n)>nγδ𝑛𝑛𝛾𝛿\log(n)>n\gamma\deltaroman_log ( italic_n ) > italic_n italic_γ italic_δ, then we have from (\arabicequation) that

(Ynγδ+τ)exp(9/2log2(n)3log(n))1/n.𝑌𝑛𝛾𝛿𝜏92superscript2𝑛3𝑛1𝑛\mathbb{P}\big{(}Y\geq n\gamma\delta+\tau\big{)}\leq\exp\Big{(}\frac{-9/2\cdot% \log^{2}(n)}{3\log(n)}\Big{)}\leq 1/n.blackboard_P ( italic_Y ≥ italic_n italic_γ italic_δ + italic_τ ) ≤ roman_exp ( divide start_ARG - 9 / 2 ⋅ roman_log start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT ( italic_n ) end_ARG start_ARG 3 roman_log ( italic_n ) end_ARG ) ≤ 1 / italic_n .

Otherwise, if nγδ>log(n)𝑛𝛾𝛿𝑛n\gamma\delta>\log(n)italic_n italic_γ italic_δ > roman_log ( italic_n ), then we have from (\arabicequation) that

(Ynγδ+τ)exp(9/2(nγδ)23nγδ)exp(nγδ)1/n.𝑌𝑛𝛾𝛿𝜏92superscript𝑛𝛾𝛿23𝑛𝛾𝛿𝑛𝛾𝛿1𝑛\mathbb{P}\big{(}Y\geq n\gamma\delta+\tau\big{)}\leq\exp\Big{(}\frac{-9/2\cdot% (n\gamma\delta)^{2}}{3n\gamma\delta}\Big{)}\leq\exp(-n\gamma\delta)\leq 1/n.blackboard_P ( italic_Y ≥ italic_n italic_γ italic_δ + italic_τ ) ≤ roman_exp ( divide start_ARG - 9 / 2 ⋅ ( italic_n italic_γ italic_δ ) start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT end_ARG start_ARG 3 italic_n italic_γ italic_δ end_ARG ) ≤ roman_exp ( - italic_n italic_γ italic_δ ) ≤ 1 / italic_n .

Hence, we are done.

Next, we aim to bound σmin((M~(s))M~(t))subscript𝜎superscriptsuperscript~𝑀𝑠topsuperscript~𝑀𝑡\sigma_{\min}((\widetilde{M}^{(s)})^{\top}\widetilde{M}^{(t)})italic_σ start_POSTSUBSCRIPT roman_min end_POSTSUBSCRIPT ( ( over~ start_ARG italic_M end_ARG start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT ⊤ end_POSTSUPERSCRIPT over~ start_ARG italic_M end_ARG start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ).

Lemma .\arabictheorem.

Given Assumption \arabicsection.\arabicsubsection, consider particular time indices s,t[0,1]𝑠𝑡01s,t\in[0,1]italic_s , italic_t ∈ [ 0 , 1 ]. Define h=L(M(s),M(t))𝐿superscript𝑀𝑠superscript𝑀𝑡h=L(M^{(s)},M^{(t)})italic_h = italic_L ( italic_M start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT , italic_M start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ). Then, for any two community matrices M(s)superscript𝑀𝑠M^{(s)}italic_M start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT and M(t)superscript𝑀𝑡M^{(t)}italic_M start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT and their column-normalized versions M~(s)superscriptnormal-~𝑀𝑠\widetilde{M}^{(s)}over~ start_ARG italic_M end_ARG start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT and M~(t)superscriptnormal-~𝑀𝑡\widetilde{M}^{(t)}over~ start_ARG italic_M end_ARG start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT,

σmin((M~(s))M~(t))1ch1/2,subscript𝜎superscriptsuperscript~𝑀𝑠topsuperscript~𝑀𝑡1𝑐superscript12\sigma_{\min}\big{(}(\widetilde{M}^{(s)})^{\top}\widetilde{M}^{(t)}\big{)}\geq 1% -ch^{1/2},italic_σ start_POSTSUBSCRIPT roman_min end_POSTSUBSCRIPT ( ( over~ start_ARG italic_M end_ARG start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT ⊤ end_POSTSUPERSCRIPT over~ start_ARG italic_M end_ARG start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ) ≥ 1 - italic_c italic_h start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT ,

where c=(2c2K)1/2+c23/2K/2𝑐superscript2subscript𝑐2𝐾12superscriptsubscript𝑐232𝐾2c=(2c_{2}K)^{1/2}+c_{2}^{3/2}K/2italic_c = ( 2 italic_c start_POSTSUBSCRIPT 2 end_POSTSUBSCRIPT italic_K ) start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT + italic_c start_POSTSUBSCRIPT 2 end_POSTSUBSCRIPT start_POSTSUPERSCRIPT 3 / 2 end_POSTSUPERSCRIPT italic_K / 2.

Proof .\arabictheorem.

Observe that for any permutation matrix RK𝑅subscript𝐾R\in\mathbb{Q}_{K}italic_R ∈ blackboard_Q start_POSTSUBSCRIPT italic_K end_POSTSUBSCRIPT,

σmin((M~(s))M~(t))=σmin((M~(s))M~(t)R).subscript𝜎superscriptsuperscript~𝑀𝑠topsuperscript~𝑀𝑡subscript𝜎superscriptsuperscript~𝑀𝑠topsuperscript~𝑀𝑡𝑅\sigma_{\min}\big{(}(\widetilde{M}^{(s)})^{\top}\widetilde{M}^{(t)}\big{)}=% \sigma_{\min}\big{(}(\widetilde{M}^{(s)})^{\top}\widetilde{M}^{(t)}R\big{)}.italic_σ start_POSTSUBSCRIPT roman_min end_POSTSUBSCRIPT ( ( over~ start_ARG italic_M end_ARG start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT ⊤ end_POSTSUPERSCRIPT over~ start_ARG italic_M end_ARG start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ) = italic_σ start_POSTSUBSCRIPT roman_min end_POSTSUBSCRIPT ( ( over~ start_ARG italic_M end_ARG start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT ⊤ end_POSTSUPERSCRIPT over~ start_ARG italic_M end_ARG start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT italic_R ) .

Hence, for notational convenience, let M0=M(s)subscript𝑀0superscript𝑀𝑠M_{0}=M^{(s)}italic_M start_POSTSUBSCRIPT 0 end_POSTSUBSCRIPT = italic_M start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT, Δ0=Δ(s)subscriptnormal-Δ0superscriptnormal-Δ𝑠\Delta_{0}=\Delta^{(s)}roman_Δ start_POSTSUBSCRIPT 0 end_POSTSUBSCRIPT = roman_Δ start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT denote a diagonal matrix where the diagonal entries denote the column sum of M0subscript𝑀0M_{0}italic_M start_POSTSUBSCRIPT 0 end_POSTSUBSCRIPT. Additionally, let

M1=M(t)R,such that R=minRKM(s)M(t)R0,formulae-sequencesubscript𝑀1superscript𝑀𝑡superscript𝑅such that superscript𝑅subscript𝑅subscript𝐾subscriptnormsuperscript𝑀𝑠superscript𝑀𝑡𝑅0M_{1}=M^{(t)}R^{\prime},\quad\text{such that }R^{\prime}=\min_{R\in\mathbb{Q}_% {K}}\|M^{(s)}-M^{(t)}R\|_{0},italic_M start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT = italic_M start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT italic_R start_POSTSUPERSCRIPT ′ end_POSTSUPERSCRIPT , such that italic_R start_POSTSUPERSCRIPT ′ end_POSTSUPERSCRIPT = roman_min start_POSTSUBSCRIPT italic_R ∈ blackboard_Q start_POSTSUBSCRIPT italic_K end_POSTSUBSCRIPT end_POSTSUBSCRIPT ∥ italic_M start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT - italic_M start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT italic_R ∥ start_POSTSUBSCRIPT 0 end_POSTSUBSCRIPT ,

and Δ1subscriptnormal-Δ1\Delta_{1}roman_Δ start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT denote the diagonal matrix where the diagonal entries denote the column sum of M1subscript𝑀1M_{1}italic_M start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT. Hence, M~0=M0(Δ0)1/2subscriptnormal-~𝑀0subscript𝑀0superscriptsubscriptnormal-Δ012\widetilde{M}_{0}=M_{0}(\Delta_{0})^{-1/2}over~ start_ARG italic_M end_ARG start_POSTSUBSCRIPT 0 end_POSTSUBSCRIPT = italic_M start_POSTSUBSCRIPT 0 end_POSTSUBSCRIPT ( roman_Δ start_POSTSUBSCRIPT 0 end_POSTSUBSCRIPT ) start_POSTSUPERSCRIPT - 1 / 2 end_POSTSUPERSCRIPT and M~1=M1(Δ1)1/2subscriptnormal-~𝑀1subscript𝑀1superscriptsubscriptnormal-Δ112\widetilde{M}_{1}=M_{1}(\Delta_{1})^{-1/2}over~ start_ARG italic_M end_ARG start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT = italic_M start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT ( roman_Δ start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT ) start_POSTSUPERSCRIPT - 1 / 2 end_POSTSUPERSCRIPT. Then,

σmin((M~(s))M~(t))subscript𝜎superscriptsuperscript~𝑀𝑠topsuperscript~𝑀𝑡\displaystyle\sigma_{\min}\big{(}(\widetilde{M}^{(s)})^{\top}\widetilde{M}^{(t% )}\big{)}italic_σ start_POSTSUBSCRIPT roman_min end_POSTSUBSCRIPT ( ( over~ start_ARG italic_M end_ARG start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT ⊤ end_POSTSUPERSCRIPT over~ start_ARG italic_M end_ARG start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ) =σmin((M~0)M~1)=σmin((M~0)M~0+(M~0)(M~1M~0))absentsubscript𝜎superscriptsubscript~𝑀0topsubscript~𝑀1subscript𝜎superscriptsubscript~𝑀0topsubscript~𝑀0superscriptsubscript~𝑀0topsubscript~𝑀1subscript~𝑀0\displaystyle=\sigma_{\min}\big{(}(\widetilde{M}_{0})^{\top}\widetilde{M}_{1}% \big{)}=\sigma_{\min}\big{(}(\widetilde{M}_{0})^{\top}\widetilde{M}_{0}+(% \widetilde{M}_{0})^{\top}(\widetilde{M}_{1}-\widetilde{M}_{0})\big{)}= italic_σ start_POSTSUBSCRIPT roman_min end_POSTSUBSCRIPT ( ( over~ start_ARG italic_M end_ARG start_POSTSUBSCRIPT 0 end_POSTSUBSCRIPT ) start_POSTSUPERSCRIPT ⊤ end_POSTSUPERSCRIPT over~ start_ARG italic_M end_ARG start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT ) = italic_σ start_POSTSUBSCRIPT roman_min end_POSTSUBSCRIPT ( ( over~ start_ARG italic_M end_ARG start_POSTSUBSCRIPT 0 end_POSTSUBSCRIPT ) start_POSTSUPERSCRIPT ⊤ end_POSTSUPERSCRIPT over~ start_ARG italic_M end_ARG start_POSTSUBSCRIPT 0 end_POSTSUBSCRIPT + ( over~ start_ARG italic_M end_ARG start_POSTSUBSCRIPT 0 end_POSTSUBSCRIPT ) start_POSTSUPERSCRIPT ⊤ end_POSTSUPERSCRIPT ( over~ start_ARG italic_M end_ARG start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT - over~ start_ARG italic_M end_ARG start_POSTSUBSCRIPT 0 end_POSTSUBSCRIPT ) )
(i)1σmax((M~0)(M~1M~0))(ii)1M~1M~0op,𝑖1subscript𝜎superscriptsubscript~𝑀0topsubscript~𝑀1subscript~𝑀0𝑖𝑖1subscriptnormsubscript~𝑀1subscript~𝑀0op\displaystyle\overset{(i)}{\geq}1-\sigma_{\max}\big{(}(\widetilde{M}_{0})^{% \top}(\widetilde{M}_{1}-\widetilde{M}_{0})\big{)}\overset{(ii)}{\geq}1-\big{\|% }\widetilde{M}_{1}-\widetilde{M}_{0}\big{\|}_{\operatorname{{op}}},start_OVERACCENT ( italic_i ) end_OVERACCENT start_ARG ≥ end_ARG 1 - italic_σ start_POSTSUBSCRIPT roman_max end_POSTSUBSCRIPT ( ( over~ start_ARG italic_M end_ARG start_POSTSUBSCRIPT 0 end_POSTSUBSCRIPT ) start_POSTSUPERSCRIPT ⊤ end_POSTSUPERSCRIPT ( over~ start_ARG italic_M end_ARG start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT - over~ start_ARG italic_M end_ARG start_POSTSUBSCRIPT 0 end_POSTSUBSCRIPT ) ) start_OVERACCENT ( italic_i italic_i ) end_OVERACCENT start_ARG ≥ end_ARG 1 - ∥ over~ start_ARG italic_M end_ARG start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT - over~ start_ARG italic_M end_ARG start_POSTSUBSCRIPT 0 end_POSTSUBSCRIPT ∥ start_POSTSUBSCRIPT roman_op end_POSTSUBSCRIPT , (\arabicequation)

where (i)𝑖(i)( italic_i ) holds since the spectral radius of I+A𝐼𝐴I+Aitalic_I + italic_A for an identity matrix I𝐼Iitalic_I and arbitrary A𝐴Aitalic_A is contained within 1±Aopplus-or-minus1subscriptnorm𝐴normal-op1\pm\|A\|_{\operatorname{{op}}}1 ± ∥ italic_A ∥ start_POSTSUBSCRIPT roman_op end_POSTSUBSCRIPT and (ii)𝑖𝑖(ii)( italic_i italic_i ) holds by submultiplicativity of the spectral norm. Since M~0=M0Δ01/2subscriptnormal-~𝑀0subscript𝑀0superscriptsubscriptnormal-Δ012\widetilde{M}_{0}=M_{0}\Delta_{0}^{-1/2}over~ start_ARG italic_M end_ARG start_POSTSUBSCRIPT 0 end_POSTSUBSCRIPT = italic_M start_POSTSUBSCRIPT 0 end_POSTSUBSCRIPT roman_Δ start_POSTSUBSCRIPT 0 end_POSTSUBSCRIPT start_POSTSUPERSCRIPT - 1 / 2 end_POSTSUPERSCRIPT and M~1=M1Δ11/2subscriptnormal-~𝑀1subscript𝑀1superscriptsubscriptnormal-Δ112\widetilde{M}_{1}=M_{1}\Delta_{1}^{-1/2}over~ start_ARG italic_M end_ARG start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT = italic_M start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT roman_Δ start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT start_POSTSUPERSCRIPT - 1 / 2 end_POSTSUPERSCRIPT, we additionally observe

M~1M~0opsubscriptnormsubscript~𝑀1subscript~𝑀0op\displaystyle\big{\|}\widetilde{M}_{1}-\widetilde{M}_{0}\big{\|}_{% \operatorname{{op}}}∥ over~ start_ARG italic_M end_ARG start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT - over~ start_ARG italic_M end_ARG start_POSTSUBSCRIPT 0 end_POSTSUBSCRIPT ∥ start_POSTSUBSCRIPT roman_op end_POSTSUBSCRIPT =M1Δ11/2M0Δ01/2±M0Δ11/2opabsentsubscriptnormplus-or-minussubscript𝑀1superscriptsubscriptΔ112subscript𝑀0superscriptsubscriptΔ012subscript𝑀0superscriptsubscriptΔ112op\displaystyle=\big{\|}M_{1}\Delta_{1}^{-1/2}-M_{0}\Delta_{0}^{-1/2}\pm M_{0}% \Delta_{1}^{-1/2}\big{\|}_{\operatorname{{op}}}= ∥ italic_M start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT roman_Δ start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT start_POSTSUPERSCRIPT - 1 / 2 end_POSTSUPERSCRIPT - italic_M start_POSTSUBSCRIPT 0 end_POSTSUBSCRIPT roman_Δ start_POSTSUBSCRIPT 0 end_POSTSUBSCRIPT start_POSTSUPERSCRIPT - 1 / 2 end_POSTSUPERSCRIPT ± italic_M start_POSTSUBSCRIPT 0 end_POSTSUBSCRIPT roman_Δ start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT start_POSTSUPERSCRIPT - 1 / 2 end_POSTSUPERSCRIPT ∥ start_POSTSUBSCRIPT roman_op end_POSTSUBSCRIPT
(M1M0)Δ11/2op+M0(Δ11/2Δ01/2)opabsentsubscriptnormsubscript𝑀1subscript𝑀0superscriptsubscriptΔ112opsubscriptnormsubscript𝑀0superscriptsubscriptΔ112superscriptsubscriptΔ012op\displaystyle\leq\big{\|}(M_{1}-M_{0})\Delta_{1}^{-1/2}\big{\|}_{\operatorname% {{op}}}+\big{\|}M_{0}(\Delta_{1}^{-1/2}-\Delta_{0}^{-1/2})\big{\|}_{% \operatorname{{op}}}≤ ∥ ( italic_M start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT - italic_M start_POSTSUBSCRIPT 0 end_POSTSUBSCRIPT ) roman_Δ start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT start_POSTSUPERSCRIPT - 1 / 2 end_POSTSUPERSCRIPT ∥ start_POSTSUBSCRIPT roman_op end_POSTSUBSCRIPT + ∥ italic_M start_POSTSUBSCRIPT 0 end_POSTSUBSCRIPT ( roman_Δ start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT start_POSTSUPERSCRIPT - 1 / 2 end_POSTSUPERSCRIPT - roman_Δ start_POSTSUBSCRIPT 0 end_POSTSUBSCRIPT start_POSTSUPERSCRIPT - 1 / 2 end_POSTSUPERSCRIPT ) ∥ start_POSTSUBSCRIPT roman_op end_POSTSUBSCRIPT
M1M0opΔ11/2op+M0opΔ11/2Δ01/2opabsentsubscriptnormsubscript𝑀1subscript𝑀0opsubscriptnormsuperscriptsubscriptΔ112opsubscriptnormsubscript𝑀0opsubscriptnormsuperscriptsubscriptΔ112superscriptsubscriptΔ012op\displaystyle\leq\big{\|}M_{1}-M_{0}\big{\|}_{\operatorname{{op}}}\|\Delta_{1}% ^{-1/2}\|_{\operatorname{{op}}}+\|M_{0}\|_{\operatorname{{op}}}\big{\|}\Delta_% {1}^{-1/2}-\Delta_{0}^{-1/2}\big{\|}_{\operatorname{{op}}}≤ ∥ italic_M start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT - italic_M start_POSTSUBSCRIPT 0 end_POSTSUBSCRIPT ∥ start_POSTSUBSCRIPT roman_op end_POSTSUBSCRIPT ∥ roman_Δ start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT start_POSTSUPERSCRIPT - 1 / 2 end_POSTSUPERSCRIPT ∥ start_POSTSUBSCRIPT roman_op end_POSTSUBSCRIPT + ∥ italic_M start_POSTSUBSCRIPT 0 end_POSTSUBSCRIPT ∥ start_POSTSUBSCRIPT roman_op end_POSTSUBSCRIPT ∥ roman_Δ start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT start_POSTSUPERSCRIPT - 1 / 2 end_POSTSUPERSCRIPT - roman_Δ start_POSTSUBSCRIPT 0 end_POSTSUBSCRIPT start_POSTSUPERSCRIPT - 1 / 2 end_POSTSUPERSCRIPT ∥ start_POSTSUBSCRIPT roman_op end_POSTSUBSCRIPT (\arabicequation)

To bound M1M0opsubscriptnormsubscript𝑀1subscript𝑀0normal-op\big{\|}M_{1}-M_{0}\big{\|}_{\operatorname{{op}}}∥ italic_M start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT - italic_M start_POSTSUBSCRIPT 0 end_POSTSUBSCRIPT ∥ start_POSTSUBSCRIPT roman_op end_POSTSUBSCRIPT, observe that M1M00=2nhsubscriptnormsubscript𝑀1subscript𝑀002𝑛\|M_{1}-M_{0}\|_{0}=2nh∥ italic_M start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT - italic_M start_POSTSUBSCRIPT 0 end_POSTSUBSCRIPT ∥ start_POSTSUBSCRIPT 0 end_POSTSUBSCRIPT = 2 italic_n italic_h thanks to our permutation of columns above via Rsuperscript𝑅normal-′R^{\prime}italic_R start_POSTSUPERSCRIPT ′ end_POSTSUPERSCRIPT. Rearrange the rows of M1M0subscript𝑀1subscript𝑀0M_{1}-M_{0}italic_M start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT - italic_M start_POSTSUBSCRIPT 0 end_POSTSUBSCRIPT such that the first nh𝑛nhitalic_n italic_h rows of M1M0subscript𝑀1subscript𝑀0M_{1}-M_{0}italic_M start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT - italic_M start_POSTSUBSCRIPT 0 end_POSTSUBSCRIPT have one 1 and one -1 in each row (and all remaining values are 0) and the remaining rows of M1M0subscript𝑀1subscript𝑀0M_{1}-M_{0}italic_M start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT - italic_M start_POSTSUBSCRIPT 0 end_POSTSUBSCRIPT are all 0’s. Then, consider the matrix (M1M0)(M1M0)subscript𝑀1subscript𝑀0superscriptsubscript𝑀1subscript𝑀0top(M_{1}-M_{0})(M_{1}-M_{0})^{\top}( italic_M start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT - italic_M start_POSTSUBSCRIPT 0 end_POSTSUBSCRIPT ) ( italic_M start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT - italic_M start_POSTSUBSCRIPT 0 end_POSTSUBSCRIPT ) start_POSTSUPERSCRIPT ⊤ end_POSTSUPERSCRIPT, where the top-left nh×nh𝑛𝑛nh\times nhitalic_n italic_h × italic_n italic_h submatrix has values {0,1,2}012\{0,1,2\}{ 0 , 1 , 2 } in absolute value. Let this submatrix be called E𝐸Eitalic_E. Then,

λmax((M1M0)(M1M0))=λmax(E)(i)2nh,subscript𝜆subscript𝑀1subscript𝑀0superscriptsubscript𝑀1subscript𝑀0topsubscript𝜆𝐸𝑖2𝑛\lambda_{\max}\big{(}(M_{1}-M_{0})(M_{1}-M_{0})^{\top}\big{)}=\lambda_{\max}(E% )\overset{(i)}{\leq}2nh,italic_λ start_POSTSUBSCRIPT roman_max end_POSTSUBSCRIPT ( ( italic_M start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT - italic_M start_POSTSUBSCRIPT 0 end_POSTSUBSCRIPT ) ( italic_M start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT - italic_M start_POSTSUBSCRIPT 0 end_POSTSUBSCRIPT ) start_POSTSUPERSCRIPT ⊤ end_POSTSUPERSCRIPT ) = italic_λ start_POSTSUBSCRIPT roman_max end_POSTSUBSCRIPT ( italic_E ) start_OVERACCENT ( italic_i ) end_OVERACCENT start_ARG ≤ end_ARG 2 italic_n italic_h ,

where (i)𝑖(i)( italic_i ) is an upper-bound relying on the maximum value of E𝐸Eitalic_E. Therefore, we have shown that M1M0op(2nh)1/2subscriptnormsubscript𝑀1subscript𝑀0normal-opsuperscript2𝑛12\|M_{1}-M_{0}\|_{\operatorname{{op}}}\leq(2nh)^{1/2}∥ italic_M start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT - italic_M start_POSTSUBSCRIPT 0 end_POSTSUBSCRIPT ∥ start_POSTSUBSCRIPT roman_op end_POSTSUBSCRIPT ≤ ( 2 italic_n italic_h ) start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT.

Let nmin=n/(c2K)subscript𝑛𝑛subscript𝑐2𝐾n_{\min}=n/(c_{2}K)italic_n start_POSTSUBSCRIPT roman_min end_POSTSUBSCRIPT = italic_n / ( italic_c start_POSTSUBSCRIPT 2 end_POSTSUBSCRIPT italic_K ) be defined as the smallest allowable community size, as specified by Assumption \arabicsection.\arabicsubsection. To bound Δ11/2Δ01/2opsubscriptnormsuperscriptsubscriptnormal-Δ112superscriptsubscriptnormal-Δ012normal-op\|\Delta_{1}^{-1/2}-\Delta_{0}^{-1/2}\|_{\operatorname{{op}}}∥ roman_Δ start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT start_POSTSUPERSCRIPT - 1 / 2 end_POSTSUPERSCRIPT - roman_Δ start_POSTSUBSCRIPT 0 end_POSTSUBSCRIPT start_POSTSUPERSCRIPT - 1 / 2 end_POSTSUPERSCRIPT ∥ start_POSTSUBSCRIPT roman_op end_POSTSUBSCRIPT, consider a particular community k{1,K}𝑘1normal-…𝐾k\in\{1,\ldots K\}italic_k ∈ { 1 , … italic_K }. Observe that

n1,k1/2n0,k1/2superscriptsubscript𝑛1𝑘12superscriptsubscript𝑛0𝑘12\displaystyle n_{1,k}^{-1/2}-n_{0,k}^{-1/2}italic_n start_POSTSUBSCRIPT 1 , italic_k end_POSTSUBSCRIPT start_POSTSUPERSCRIPT - 1 / 2 end_POSTSUPERSCRIPT - italic_n start_POSTSUBSCRIPT 0 , italic_k end_POSTSUBSCRIPT start_POSTSUPERSCRIPT - 1 / 2 end_POSTSUPERSCRIPT =1n1,k1n0,k=n1,kn0,kn1,kn0,k=n1,kn0,kn1,kn0,k(n1,k+n0,k)nh2nmin3/2.absent1subscript𝑛1𝑘1subscript𝑛0𝑘subscript𝑛1𝑘subscript𝑛0𝑘subscript𝑛1𝑘subscript𝑛0𝑘subscript𝑛1𝑘subscript𝑛0𝑘subscript𝑛1𝑘subscript𝑛0𝑘subscript𝑛1𝑘subscript𝑛0𝑘𝑛2superscriptsubscript𝑛32\displaystyle=\frac{1}{\sqrt{n_{1,k}}}-\frac{1}{\sqrt{n_{0,k}}}=\frac{\sqrt{n_% {1,k}}-\sqrt{n_{0,k}}}{\sqrt{n_{1,k}n_{0,k}}}=\frac{n_{1,k}-n_{0,k}}{\sqrt{n_{% 1,k}n_{0,k}}(\sqrt{n_{1,k}}+\sqrt{n_{0,k}})}\leq\frac{nh}{2n_{\min}^{3/2}}.= divide start_ARG 1 end_ARG start_ARG square-root start_ARG italic_n start_POSTSUBSCRIPT 1 , italic_k end_POSTSUBSCRIPT end_ARG end_ARG - divide start_ARG 1 end_ARG start_ARG square-root start_ARG italic_n start_POSTSUBSCRIPT 0 , italic_k end_POSTSUBSCRIPT end_ARG end_ARG = divide start_ARG square-root start_ARG italic_n start_POSTSUBSCRIPT 1 , italic_k end_POSTSUBSCRIPT end_ARG - square-root start_ARG italic_n start_POSTSUBSCRIPT 0 , italic_k end_POSTSUBSCRIPT end_ARG end_ARG start_ARG square-root start_ARG italic_n start_POSTSUBSCRIPT 1 , italic_k end_POSTSUBSCRIPT italic_n start_POSTSUBSCRIPT 0 , italic_k end_POSTSUBSCRIPT end_ARG end_ARG = divide start_ARG italic_n start_POSTSUBSCRIPT 1 , italic_k end_POSTSUBSCRIPT - italic_n start_POSTSUBSCRIPT 0 , italic_k end_POSTSUBSCRIPT end_ARG start_ARG square-root start_ARG italic_n start_POSTSUBSCRIPT 1 , italic_k end_POSTSUBSCRIPT italic_n start_POSTSUBSCRIPT 0 , italic_k end_POSTSUBSCRIPT end_ARG ( square-root start_ARG italic_n start_POSTSUBSCRIPT 1 , italic_k end_POSTSUBSCRIPT end_ARG + square-root start_ARG italic_n start_POSTSUBSCRIPT 0 , italic_k end_POSTSUBSCRIPT end_ARG ) end_ARG ≤ divide start_ARG italic_n italic_h end_ARG start_ARG 2 italic_n start_POSTSUBSCRIPT roman_min end_POSTSUBSCRIPT start_POSTSUPERSCRIPT 3 / 2 end_POSTSUPERSCRIPT end_ARG .

This means that Δ11/2Δ01/2opnh/(2nmin3/2)subscriptnormsuperscriptsubscriptnormal-Δ112superscriptsubscriptnormal-Δ012normal-op𝑛2superscriptsubscript𝑛32\|\Delta_{1}^{-1/2}-\Delta_{0}^{-1/2}\|_{\operatorname{{op}}}\leq nh/(2n_{\min% }^{3/2})∥ roman_Δ start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT start_POSTSUPERSCRIPT - 1 / 2 end_POSTSUPERSCRIPT - roman_Δ start_POSTSUBSCRIPT 0 end_POSTSUBSCRIPT start_POSTSUPERSCRIPT - 1 / 2 end_POSTSUPERSCRIPT ∥ start_POSTSUBSCRIPT roman_op end_POSTSUBSCRIPT ≤ italic_n italic_h / ( 2 italic_n start_POSTSUBSCRIPT roman_min end_POSTSUBSCRIPT start_POSTSUPERSCRIPT 3 / 2 end_POSTSUPERSCRIPT ).

Plugging our results into (\arabicequation), we have

M~1M~0op(2nh)1/21nmin1/2+nmax1/2nh2nmin3/2(i)((2c2K)1/2+c23/2K2)h1/2subscriptnormsubscript~𝑀1subscript~𝑀0opsuperscript2𝑛121superscriptsubscript𝑛12superscriptsubscript𝑛12𝑛2superscriptsubscript𝑛32𝑖superscript2subscript𝑐2𝐾12superscriptsubscript𝑐232𝐾2superscript12\big{\|}\widetilde{M}_{1}-\widetilde{M}_{0}\big{\|}_{\operatorname{{op}}}\leq(% 2nh)^{1/2}\cdot\frac{1}{n_{\min}^{1/2}}+n_{\max}^{1/2}\cdot\frac{nh}{2n_{\min}% ^{3/2}}\overset{(i)}{\leq}\Big{(}(2c_{2}K)^{1/2}+\frac{c_{2}^{3/2}K}{2}\Big{)}% \cdot h^{1/2}∥ over~ start_ARG italic_M end_ARG start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT - over~ start_ARG italic_M end_ARG start_POSTSUBSCRIPT 0 end_POSTSUBSCRIPT ∥ start_POSTSUBSCRIPT roman_op end_POSTSUBSCRIPT ≤ ( 2 italic_n italic_h ) start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT ⋅ divide start_ARG 1 end_ARG start_ARG italic_n start_POSTSUBSCRIPT roman_min end_POSTSUBSCRIPT start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT end_ARG + italic_n start_POSTSUBSCRIPT roman_max end_POSTSUBSCRIPT start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT ⋅ divide start_ARG italic_n italic_h end_ARG start_ARG 2 italic_n start_POSTSUBSCRIPT roman_min end_POSTSUBSCRIPT start_POSTSUPERSCRIPT 3 / 2 end_POSTSUPERSCRIPT end_ARG start_OVERACCENT ( italic_i ) end_OVERACCENT start_ARG ≤ end_ARG ( ( 2 italic_c start_POSTSUBSCRIPT 2 end_POSTSUBSCRIPT italic_K ) start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT + divide start_ARG italic_c start_POSTSUBSCRIPT 2 end_POSTSUBSCRIPT start_POSTSUPERSCRIPT 3 / 2 end_POSTSUPERSCRIPT italic_K end_ARG start_ARG 2 end_ARG ) ⋅ italic_h start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT

where (i)𝑖(i)( italic_i ) holds from Assumption \arabicsection.\arabicsubsection and recalling that h11h\leq 1italic_h ≤ 1. Plugging this into (\arabicequation), we are done.

Next, we aim to bound the spectral difference between M~(s)(M~(s))superscript~𝑀𝑠superscriptsuperscript~𝑀𝑠top\widetilde{M}^{(s)}(\widetilde{M}^{(s)})^{\top}over~ start_ARG italic_M end_ARG start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT ( over~ start_ARG italic_M end_ARG start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT ⊤ end_POSTSUPERSCRIPT and M~(t)(M~(t))superscript~𝑀𝑡superscriptsuperscript~𝑀𝑡top\widetilde{M}^{(t)}(\widetilde{M}^{(t)})^{\top}over~ start_ARG italic_M end_ARG start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ( over~ start_ARG italic_M end_ARG start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT ⊤ end_POSTSUPERSCRIPT

Lemma .\arabictheorem.

For any two membership matrices M(s)superscript𝑀𝑠M^{(s)}italic_M start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT and M(t)superscript𝑀𝑡M^{(t)}italic_M start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT,

M~(s)(M~(s))M~(t)(M~(t))op2ch1/2,subscriptnormsuperscript~𝑀𝑠superscriptsuperscript~𝑀𝑠topsuperscript~𝑀𝑡superscriptsuperscript~𝑀𝑡topop2𝑐superscript12\Big{\|}\widetilde{M}^{(s)}(\widetilde{M}^{(s)})^{\top}-\widetilde{M}^{(t)}(% \widetilde{M}^{(t)})^{\top}\Big{\|}_{\operatorname{{op}}}\leq 2ch^{1/2},∥ over~ start_ARG italic_M end_ARG start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT ( over~ start_ARG italic_M end_ARG start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT ⊤ end_POSTSUPERSCRIPT - over~ start_ARG italic_M end_ARG start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ( over~ start_ARG italic_M end_ARG start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT ⊤ end_POSTSUPERSCRIPT ∥ start_POSTSUBSCRIPT roman_op end_POSTSUBSCRIPT ≤ 2 italic_c italic_h start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT ,

where c𝑐citalic_c and hhitalic_h are defined in Lemma .\arabictheorem.

Proof .\arabictheorem.

For notational convenience, let M0=M(s)subscript𝑀0superscript𝑀𝑠M_{0}=M^{(s)}italic_M start_POSTSUBSCRIPT 0 end_POSTSUBSCRIPT = italic_M start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT and M1=M(t)subscript𝑀1superscript𝑀𝑡M_{1}=M^{(t)}italic_M start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT = italic_M start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT. We will invoke properties about the distance between two orthonormal matrices (see Lemma 1 from Cai et al. (2018) for example). Specifically,

M~1(M~1)M~0(M~0)op2(1σmin2(M~1M~0))1/2.subscriptnormsubscript~𝑀1superscriptsubscript~𝑀1topsubscript~𝑀0superscriptsubscript~𝑀0topop2superscript1subscriptsuperscript𝜎2superscriptsubscript~𝑀1topsubscript~𝑀012\Big{\|}\widetilde{M}_{1}(\widetilde{M}_{1})^{\top}-\widetilde{M}_{0}(% \widetilde{M}_{0})^{\top}\Big{\|}_{\operatorname{{op}}}\leq 2\cdot\Big{(}1-% \sigma^{2}_{\min}(\widetilde{M}_{1}^{\top}\widetilde{M}_{0})\Big{)}^{1/2}.∥ over~ start_ARG italic_M end_ARG start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT ( over~ start_ARG italic_M end_ARG start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT ) start_POSTSUPERSCRIPT ⊤ end_POSTSUPERSCRIPT - over~ start_ARG italic_M end_ARG start_POSTSUBSCRIPT 0 end_POSTSUBSCRIPT ( over~ start_ARG italic_M end_ARG start_POSTSUBSCRIPT 0 end_POSTSUBSCRIPT ) start_POSTSUPERSCRIPT ⊤ end_POSTSUPERSCRIPT ∥ start_POSTSUBSCRIPT roman_op end_POSTSUBSCRIPT ≤ 2 ⋅ ( 1 - italic_σ start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT start_POSTSUBSCRIPT roman_min end_POSTSUBSCRIPT ( over~ start_ARG italic_M end_ARG start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT start_POSTSUPERSCRIPT ⊤ end_POSTSUPERSCRIPT over~ start_ARG italic_M end_ARG start_POSTSUBSCRIPT 0 end_POSTSUBSCRIPT ) ) start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT .

Hence, we can invoke Lemma .\arabictheorem to finish the proof,

M~1(M~1)M~0(M~0)opsubscriptnormsubscript~𝑀1superscriptsubscript~𝑀1topsubscript~𝑀0superscriptsubscript~𝑀0topop\displaystyle\Big{\|}\widetilde{M}_{1}(\widetilde{M}_{1})^{\top}-\widetilde{M}% _{0}(\widetilde{M}_{0})^{\top}\Big{\|}_{\operatorname{{op}}}∥ over~ start_ARG italic_M end_ARG start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT ( over~ start_ARG italic_M end_ARG start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT ) start_POSTSUPERSCRIPT ⊤ end_POSTSUPERSCRIPT - over~ start_ARG italic_M end_ARG start_POSTSUBSCRIPT 0 end_POSTSUBSCRIPT ( over~ start_ARG italic_M end_ARG start_POSTSUBSCRIPT 0 end_POSTSUBSCRIPT ) start_POSTSUPERSCRIPT ⊤ end_POSTSUPERSCRIPT ∥ start_POSTSUBSCRIPT roman_op end_POSTSUBSCRIPT 2(1(1ch1/2)2)1/2(i)2(1(1c2h))1/2=2ch1/2,absent2superscript1superscript1𝑐superscript12212𝑖2superscript11superscript𝑐2122𝑐superscript12\displaystyle\leq 2\cdot\big{(}1-(1-ch^{1/2})^{2}\big{)}^{1/2}\overset{(i)}{% \leq}2\cdot\big{(}1-(1-c^{2}h)\big{)}^{1/2}=2ch^{1/2},≤ 2 ⋅ ( 1 - ( 1 - italic_c italic_h start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT start_OVERACCENT ( italic_i ) end_OVERACCENT start_ARG ≤ end_ARG 2 ⋅ ( 1 - ( 1 - italic_c start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT italic_h ) ) start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT = 2 italic_c italic_h start_POSTSUPERSCRIPT 1 / 2 end_POSTSUPERSCRIPT ,

where (i)𝑖(i)( italic_i ) holds since if a,b>0𝑎𝑏0a,b>0italic_a , italic_b > 0, then (ab)2|(ab)(a+b)|=|a2b2|superscript𝑎𝑏2𝑎𝑏𝑎𝑏superscript𝑎2superscript𝑏2(a-b)^{2}\leq|(a-b)(a+b)|=|a^{2}-b^{2}|( italic_a - italic_b ) start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT ≤ | ( italic_a - italic_b ) ( italic_a + italic_b ) | = | italic_a start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT - italic_b start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT |.

Lemma .\arabictheorem.

Given Assumption \arabicsection.\arabicsubsection, for any membership matrix M(t)superscript𝑀𝑡M^{(t)}italic_M start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT, connectivity matrix B(t)superscript𝐵𝑡B^{(t)}italic_B start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT and sparsity ρnsubscript𝜌𝑛\rho_{n}italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT,

Q(t)opcρnn.subscriptnormsuperscript𝑄𝑡op𝑐subscript𝜌𝑛𝑛\big{\|}Q^{(t)}\big{\|}_{\operatorname{{op}}}\leq c\rho_{n}n.∥ italic_Q start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ∥ start_POSTSUBSCRIPT roman_op end_POSTSUBSCRIPT ≤ italic_c italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT italic_n .

for some constant c𝑐citalic_c that depends on c2subscript𝑐2c_{2}italic_c start_POSTSUBSCRIPT 2 end_POSTSUBSCRIPT and K𝐾Kitalic_K.

Proof .\arabictheorem.

Let c𝑐citalic_c be a constant that can vary from term to term, depending only on the constants c2subscript𝑐2c_{2}italic_c start_POSTSUBSCRIPT 2 end_POSTSUBSCRIPT and K𝐾Kitalic_K. Defining nmax=cnsubscript𝑛𝑐𝑛n_{\max}=cnitalic_n start_POSTSUBSCRIPT roman_max end_POSTSUBSCRIPT = italic_c italic_n as defined in Assumption \arabicsection.\arabicsubsection as the maximum cluster size, we have that

Q(t)op=ρnM(t)B(t)(M(t))opcρnn,subscriptnormsuperscript𝑄𝑡opsubscriptnormsubscript𝜌𝑛superscript𝑀𝑡superscript𝐵𝑡superscriptsuperscript𝑀𝑡topop𝑐subscript𝜌𝑛𝑛\big{\|}Q^{(t)}\big{\|}_{\operatorname{{op}}}=\big{\|}\rho_{n}M^{(t)}B^{(t)}(M% ^{(t)})^{\top}\big{\|}_{\operatorname{{op}}}\leq c\rho_{n}n,∥ italic_Q start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ∥ start_POSTSUBSCRIPT roman_op end_POSTSUBSCRIPT = ∥ italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT italic_M start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT italic_B start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ( italic_M start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT ⊤ end_POSTSUPERSCRIPT ∥ start_POSTSUBSCRIPT roman_op end_POSTSUBSCRIPT ≤ italic_c italic_ρ start_POSTSUBSCRIPT italic_n end_POSTSUBSCRIPT italic_n ,

via the submultiplicativity of the spectral norm and the fact that B(t)opKsubscriptnormsuperscript𝐵𝑡normal-op𝐾\|B^{(t)}\|_{\operatorname{{op}}}\leq K∥ italic_B start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ∥ start_POSTSUBSCRIPT roman_op end_POSTSUBSCRIPT ≤ italic_K since B(t)[0,1]K×Ksuperscript𝐵𝑡superscript01𝐾𝐾B^{(t)}\in[0,1]^{K\times K}italic_B start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ∈ [ 0 , 1 ] start_POSTSUPERSCRIPT italic_K × italic_K end_POSTSUPERSCRIPT.

Below, we upper-bound the probability that each community size stays within a certain size for a two-community model where each community is initialized to be the same size.

Lemma .\arabictheorem.

Assume a two-community model (i.e., K=2𝐾2K=2italic_K = 2) following the model described in Section \arabicsection.\arabicsubsection (using Assumption \arabicsection.\arabictheorem instead of Assumption \arabicsection.\arabicsubsection), where each community is initialized to have equal community sizes. Then, with probability at least 11/T11𝑇1-1/T1 - 1 / italic_T, each community’s size will stay within

[n2cmax{nγlog(T),log(T)},n2+cmax{nγlog(T),log(T)}],𝑛2𝑐𝑛𝛾𝑇𝑇𝑛2𝑐𝑛𝛾𝑇𝑇\Big{[}\frac{n}{2}-c\cdot\max\{\sqrt{n\gamma\log(T)},\log(T)\},\frac{n}{2}+c% \cdot\max\{\sqrt{n\gamma\log(T)},\log(T)\}\Big{]},[ divide start_ARG italic_n end_ARG start_ARG 2 end_ARG - italic_c ⋅ roman_max { square-root start_ARG italic_n italic_γ roman_log ( italic_T ) end_ARG , roman_log ( italic_T ) } , divide start_ARG italic_n end_ARG start_ARG 2 end_ARG + italic_c ⋅ roman_max { square-root start_ARG italic_n italic_γ roman_log ( italic_T ) end_ARG , roman_log ( italic_T ) } ] ,

for some universal constant c𝑐citalic_c, for all t𝒯𝑡𝒯t\in\mathcal{T}italic_t ∈ caligraphic_T.

As a note, observe that since each node changes memberships with probability γ/T𝛾𝑇\gamma/Titalic_γ / italic_T for each discrete non-overlap** time interval of length 1/T1𝑇1/T1 / italic_T, each node will have γ𝛾\gammaitalic_γ events between t=0𝑡0t=0italic_t = 0 and t=1𝑡1t=1italic_t = 1 on average. Hence, nγ𝑛𝛾n\gammaitalic_n italic_γ is the mean number of total membership changes across all nodes and all time..

Proof .\arabictheorem.

We wish to bound the community size uniformly across all time t𝒯\{1}𝑡normal-\𝒯1t\in\mathcal{T}\backslash\{1\}italic_t ∈ caligraphic_T \ { 1 }. Let Ntsubscript𝑁𝑡N_{t}italic_N start_POSTSUBSCRIPT italic_t end_POSTSUBSCRIPT denote the number of nodes in Community 1 at time t𝑡titalic_t. For t𝒯𝑡𝒯t\in\mathcal{T}italic_t ∈ caligraphic_T where t>1/T𝑡1𝑇t>1/Titalic_t > 1 / italic_T, let t=t1/Tsuperscript𝑡normal-′𝑡1𝑇t^{\prime}=t-1/Titalic_t start_POSTSUPERSCRIPT ′ end_POSTSUPERSCRIPT = italic_t - 1 / italic_T and tsubscriptsuperscript𝑡normal-′\mathcal{F}_{t^{\prime}}caligraphic_F start_POSTSUBSCRIPT italic_t start_POSTSUPERSCRIPT ′ end_POSTSUPERSCRIPT end_POSTSUBSCRIPT denote the filtration of the last time prior to t𝑡titalic_t where F0=subscript𝐹0F_{0}=\emptysetitalic_F start_POSTSUBSCRIPT 0 end_POSTSUBSCRIPT = ∅. Observe for t𝒯𝑡𝒯t\in\mathcal{T}italic_t ∈ caligraphic_T, due to the two-community setup,

𝔼[Nt|t]=Nt(1γT)+(nNt)γT,𝔼delimited-[]conditionalsubscript𝑁𝑡subscriptsuperscript𝑡subscript𝑁superscript𝑡1𝛾𝑇𝑛subscript𝑁superscript𝑡𝛾𝑇\mathbb{E}\big{[}N_{t}|\mathcal{F}_{t^{\prime}}\big{]}=N_{t^{\prime}}\cdot\big% {(}1-\frac{\gamma}{T}\big{)}+\big{(}n-N_{t^{\prime}}\big{)}\cdot\frac{\gamma}{% T},blackboard_E [ italic_N start_POSTSUBSCRIPT italic_t end_POSTSUBSCRIPT | caligraphic_F start_POSTSUBSCRIPT italic_t start_POSTSUPERSCRIPT ′ end_POSTSUPERSCRIPT end_POSTSUBSCRIPT ] = italic_N start_POSTSUBSCRIPT italic_t start_POSTSUPERSCRIPT ′ end_POSTSUPERSCRIPT end_POSTSUBSCRIPT ⋅ ( 1 - divide start_ARG italic_γ end_ARG start_ARG italic_T end_ARG ) + ( italic_n - italic_N start_POSTSUBSCRIPT italic_t start_POSTSUPERSCRIPT ′ end_POSTSUPERSCRIPT end_POSTSUBSCRIPT ) ⋅ divide start_ARG italic_γ end_ARG start_ARG italic_T end_ARG , (\arabicequation)

where N0=n/2subscript𝑁0𝑛2N_{0}=n/2italic_N start_POSTSUBSCRIPT 0 end_POSTSUBSCRIPT = italic_n / 2. Let Zt=Ntn/2subscript𝑍𝑡subscript𝑁𝑡𝑛2Z_{t}=N_{t}-n/2italic_Z start_POSTSUBSCRIPT italic_t end_POSTSUBSCRIPT = italic_N start_POSTSUBSCRIPT italic_t end_POSTSUBSCRIPT - italic_n / 2 denote the size of Community 1 deviates from parity. Certainly, Ztsubscript𝑍𝑡Z_{t}italic_Z start_POSTSUBSCRIPT italic_t end_POSTSUBSCRIPT is a symmetric random variable around 0 since both communities are initialized with equal sizes. Our goal is show that Ztsubscript𝑍𝑡Z_{t}italic_Z start_POSTSUBSCRIPT italic_t end_POSTSUBSCRIPT is concentrated near 0 for all t𝒯𝑡𝒯t\in\mathcal{T}italic_t ∈ caligraphic_T with high probability under the provided assumptions.

Towards this end, let α=12γ/T𝛼12𝛾𝑇\alpha=1-2\gamma/Titalic_α = 1 - 2 italic_γ / italic_T and β=γ/T𝛽𝛾𝑇\beta=\gamma/Titalic_β = italic_γ / italic_T. Observe that from (\arabicequation) and the definition of Ztsubscript𝑍𝑡Z_{t}italic_Z start_POSTSUBSCRIPT italic_t end_POSTSUBSCRIPT,

𝔼[Zt|t]=(12γT)Zt=αZt.𝔼delimited-[]conditionalsubscript𝑍𝑡subscriptsuperscript𝑡12𝛾𝑇subscript𝑍superscript𝑡𝛼subscript𝑍superscript𝑡\mathbb{E}\big{[}Z_{t}|\mathcal{F}_{t^{\prime}}\big{]}=\big{(}1-\frac{2\gamma}% {T}\big{)}\cdot Z_{t^{\prime}}=\alpha\cdot Z_{t^{\prime}}.blackboard_E [ italic_Z start_POSTSUBSCRIPT italic_t end_POSTSUBSCRIPT | caligraphic_F start_POSTSUBSCRIPT italic_t start_POSTSUPERSCRIPT ′ end_POSTSUPERSCRIPT end_POSTSUBSCRIPT ] = ( 1 - divide start_ARG 2 italic_γ end_ARG start_ARG italic_T end_ARG ) ⋅ italic_Z start_POSTSUBSCRIPT italic_t start_POSTSUPERSCRIPT ′ end_POSTSUPERSCRIPT end_POSTSUBSCRIPT = italic_α ⋅ italic_Z start_POSTSUBSCRIPT italic_t start_POSTSUPERSCRIPT ′ end_POSTSUPERSCRIPT end_POSTSUBSCRIPT . (\arabicequation)

where for Z0=0subscript𝑍00Z_{0}=0italic_Z start_POSTSUBSCRIPT 0 end_POSTSUBSCRIPT = 0. We can think of α𝛼\alphaitalic_α as a factor that shrinks Ztsubscript𝑍superscript𝑡normal-′Z_{t^{\prime}}italic_Z start_POSTSUBSCRIPT italic_t start_POSTSUPERSCRIPT ′ end_POSTSUPERSCRIPT end_POSTSUBSCRIPT towards 0 (i.e., equal community sizes). Define

Mt=Zt𝔼[Zt|t]=ZtαZt,𝑓𝑜𝑟t𝒯.formulae-sequencesubscript𝑀𝑡subscript𝑍𝑡𝔼delimited-[]conditionalsubscript𝑍𝑡subscriptsuperscript𝑡subscript𝑍𝑡𝛼subscript𝑍superscript𝑡𝑓𝑜𝑟𝑡𝒯M_{t}=Z_{t}-\mathbb{E}[Z_{t}|\mathcal{F}_{t^{\prime}}]=Z_{t}-\alpha Z_{t^{% \prime}},\quad\text{for}\quad t\in\mathcal{T}.italic_M start_POSTSUBSCRIPT italic_t end_POSTSUBSCRIPT = italic_Z start_POSTSUBSCRIPT italic_t end_POSTSUBSCRIPT - blackboard_E [ italic_Z start_POSTSUBSCRIPT italic_t end_POSTSUBSCRIPT | caligraphic_F start_POSTSUBSCRIPT italic_t start_POSTSUPERSCRIPT ′ end_POSTSUPERSCRIPT end_POSTSUBSCRIPT ] = italic_Z start_POSTSUBSCRIPT italic_t end_POSTSUBSCRIPT - italic_α italic_Z start_POSTSUBSCRIPT italic_t start_POSTSUPERSCRIPT ′ end_POSTSUPERSCRIPT end_POSTSUBSCRIPT , for italic_t ∈ caligraphic_T . (\arabicequation)

as the deviation of the expected size of Community 1 from its expectation at time t𝑡titalic_t. Recalling the functional form of centered Bernoulli’s, observe that from (\arabicequation) and (\arabicequation),

Mt|t=𝑑i=1nξi,tconditionalsubscript𝑀𝑡subscriptsuperscript𝑡𝑑superscriptsubscript𝑖1𝑛subscript𝜉𝑖𝑡M_{t}|\mathcal{F}_{t^{\prime}}\overset{d}{=}\sum_{i=1}^{n}\xi_{i,t}italic_M start_POSTSUBSCRIPT italic_t end_POSTSUBSCRIPT | caligraphic_F start_POSTSUBSCRIPT italic_t start_POSTSUPERSCRIPT ′ end_POSTSUPERSCRIPT end_POSTSUBSCRIPT overitalic_d start_ARG = end_ARG ∑ start_POSTSUBSCRIPT italic_i = 1 end_POSTSUBSCRIPT start_POSTSUPERSCRIPT italic_n end_POSTSUPERSCRIPT italic_ξ start_POSTSUBSCRIPT italic_i , italic_t end_POSTSUBSCRIPT (\arabicequation)

where

if i{1,,Nt},then ξi,t={βwith probability 1β(1β)with probability β,formulae-sequenceif 𝑖1subscript𝑁superscript𝑡then subscript𝜉𝑖𝑡cases𝛽with probability 1𝛽1𝛽with probability 𝛽\text{if }i\in\{1,\ldots,N_{t^{\prime}}\},\quad\text{then }\xi_{i,t}=\begin{% cases}\beta&\quad\text{with probability }1-\beta\\ -(1-\beta)&\quad\text{with probability }\beta\end{cases},if italic_i ∈ { 1 , … , italic_N start_POSTSUBSCRIPT italic_t start_POSTSUPERSCRIPT ′ end_POSTSUPERSCRIPT end_POSTSUBSCRIPT } , then italic_ξ start_POSTSUBSCRIPT italic_i , italic_t end_POSTSUBSCRIPT = { start_ROW start_CELL italic_β end_CELL start_CELL with probability 1 - italic_β end_CELL end_ROW start_ROW start_CELL - ( 1 - italic_β ) end_CELL start_CELL with probability italic_β end_CELL end_ROW ,

and

if i{Nt+1,,n},then ξi,t={1βwith probability ββwith probability 1β.formulae-sequenceif 𝑖subscript𝑁superscript𝑡1𝑛then subscript𝜉𝑖𝑡cases1𝛽with probability 𝛽𝛽with probability 1𝛽\text{if }i\in\{N_{t^{\prime}}+1,\ldots,n\},\quad\text{then }\xi_{i,t}=\begin{% cases}1-\beta&\quad\text{with probability }\beta\\ -\beta&\quad\text{with probability }1-\beta\end{cases}.if italic_i ∈ { italic_N start_POSTSUBSCRIPT italic_t start_POSTSUPERSCRIPT ′ end_POSTSUPERSCRIPT end_POSTSUBSCRIPT + 1 , … , italic_n } , then italic_ξ start_POSTSUBSCRIPT italic_i , italic_t end_POSTSUBSCRIPT = { start_ROW start_CELL 1 - italic_β end_CELL start_CELL with probability italic_β end_CELL end_ROW start_ROW start_CELL - italic_β end_CELL start_CELL with probability 1 - italic_β end_CELL end_ROW .

Without loss of generality, let t1=t=t1/Tsubscript𝑡1superscript𝑡normal-′𝑡1𝑇t_{1}=t^{\prime}=t-1/Titalic_t start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT = italic_t start_POSTSUPERSCRIPT ′ end_POSTSUPERSCRIPT = italic_t - 1 / italic_T, t2=t2/T,,tS=1/Tformulae-sequencesubscript𝑡2𝑡2𝑇normal-…subscript𝑡𝑆1𝑇t_{2}=t-2/T,\ldots,t_{S}=1/Titalic_t start_POSTSUBSCRIPT 2 end_POSTSUBSCRIPT = italic_t - 2 / italic_T , … , italic_t start_POSTSUBSCRIPT italic_S end_POSTSUBSCRIPT = 1 / italic_T for S=t(T1)1𝑆𝑡𝑇11S=t(T-1)-1italic_S = italic_t ( italic_T - 1 ) - 1. Hence, t1>t2>>tSsubscript𝑡1subscript𝑡2normal-…subscript𝑡𝑆t_{1}>t_{2}>\ldots>t_{S}italic_t start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT > italic_t start_POSTSUBSCRIPT 2 end_POSTSUBSCRIPT > … > italic_t start_POSTSUBSCRIPT italic_S end_POSTSUBSCRIPT, meaning tSsubscript𝑡𝑆t_{S}italic_t start_POSTSUBSCRIPT italic_S end_POSTSUBSCRIPT is the earliest time, and t1subscript𝑡1t_{1}italic_t start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT is the latest time. Then, building upon a recursive decomposition for (\arabicequation),

Zt=Mt+αMt1+α2Mt2++αSMtS,subscript𝑍𝑡subscript𝑀𝑡𝛼subscript𝑀subscript𝑡1superscript𝛼2subscript𝑀subscript𝑡2superscript𝛼𝑆subscript𝑀subscript𝑡𝑆Z_{t}=M_{t}+\alpha M_{t_{1}}+\alpha^{2}M_{t_{2}}+\ldots+\alpha^{S}M_{t_{S}},italic_Z start_POSTSUBSCRIPT italic_t end_POSTSUBSCRIPT = italic_M start_POSTSUBSCRIPT italic_t end_POSTSUBSCRIPT + italic_α italic_M start_POSTSUBSCRIPT italic_t start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT end_POSTSUBSCRIPT + italic_α start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT italic_M start_POSTSUBSCRIPT italic_t start_POSTSUBSCRIPT 2 end_POSTSUBSCRIPT end_POSTSUBSCRIPT + … + italic_α start_POSTSUPERSCRIPT italic_S end_POSTSUPERSCRIPT italic_M start_POSTSUBSCRIPT italic_t start_POSTSUBSCRIPT italic_S end_POSTSUBSCRIPT end_POSTSUBSCRIPT , (\arabicequation)

recalling that MtS=M1/T=0subscript𝑀subscript𝑡𝑆subscript𝑀1𝑇0M_{t_{S}}=M_{1/T}=0italic_M start_POSTSUBSCRIPT italic_t start_POSTSUBSCRIPT italic_S end_POSTSUBSCRIPT end_POSTSUBSCRIPT = italic_M start_POSTSUBSCRIPT 1 / italic_T end_POSTSUBSCRIPT = 0 by our definitions.

We seek a Chernoff-like argument. Observe that for any c>0𝑐0c>0italic_c > 0,

𝔼[ecZt]𝔼delimited-[]superscript𝑒𝑐subscript𝑍𝑡\displaystyle\mathbb{E}\big{[}e^{cZ_{t}}\big{]}blackboard_E [ italic_e start_POSTSUPERSCRIPT italic_c italic_Z start_POSTSUBSCRIPT italic_t end_POSTSUBSCRIPT end_POSTSUPERSCRIPT ] =𝔼[ec(Mt+αMt1+α2Mt2++αSMtS)]absent𝔼delimited-[]superscript𝑒𝑐subscript𝑀𝑡𝛼subscript𝑀subscript𝑡1superscript𝛼2subscript𝑀subscript𝑡2superscript𝛼𝑆subscript𝑀subscript𝑡𝑆\displaystyle=\mathbb{E}\big{[}e^{c(M_{t}+\alpha M_{t_{1}}+\alpha^{2}M_{t_{2}}% +\ldots+\alpha^{S}M_{t_{S}})}\big{]}= blackboard_E [ italic_e start_POSTSUPERSCRIPT italic_c ( italic_M start_POSTSUBSCRIPT italic_t end_POSTSUBSCRIPT + italic_α italic_M start_POSTSUBSCRIPT italic_t start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT end_POSTSUBSCRIPT + italic_α start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT italic_M start_POSTSUBSCRIPT italic_t start_POSTSUBSCRIPT 2 end_POSTSUBSCRIPT end_POSTSUBSCRIPT + … + italic_α start_POSTSUPERSCRIPT italic_S end_POSTSUPERSCRIPT italic_M start_POSTSUBSCRIPT italic_t start_POSTSUBSCRIPT italic_S end_POSTSUBSCRIPT end_POSTSUBSCRIPT ) end_POSTSUPERSCRIPT ]
=𝔼{𝔼[ec(Mt+αMt1+α2Mt2++αSMtS)|t1]}absent𝔼𝔼delimited-[]conditionalsuperscript𝑒𝑐subscript𝑀𝑡𝛼subscript𝑀subscript𝑡1superscript𝛼2subscript𝑀subscript𝑡2superscript𝛼𝑆subscript𝑀subscript𝑡𝑆subscriptsubscript𝑡1\displaystyle=\mathbb{E}\Big{\{}\mathbb{E}\big{[}e^{c(M_{t}+\alpha M_{t_{1}}+% \alpha^{2}M_{t_{2}}+\ldots+\alpha^{S}M_{t_{S}})}|\mathcal{F}_{t_{1}}\big{]}% \Big{\}}= blackboard_E { blackboard_E [ italic_e start_POSTSUPERSCRIPT italic_c ( italic_M start_POSTSUBSCRIPT italic_t end_POSTSUBSCRIPT + italic_α italic_M start_POSTSUBSCRIPT italic_t start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT end_POSTSUBSCRIPT + italic_α start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT italic_M start_POSTSUBSCRIPT italic_t start_POSTSUBSCRIPT 2 end_POSTSUBSCRIPT end_POSTSUBSCRIPT + … + italic_α start_POSTSUPERSCRIPT italic_S end_POSTSUPERSCRIPT italic_M start_POSTSUBSCRIPT italic_t start_POSTSUBSCRIPT italic_S end_POSTSUBSCRIPT end_POSTSUBSCRIPT ) end_POSTSUPERSCRIPT | caligraphic_F start_POSTSUBSCRIPT italic_t start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT end_POSTSUBSCRIPT ] }
=𝔼{𝔼[ecMt|t1]eαMt1+α2Mt2++αSMtS}.absent𝔼𝔼delimited-[]conditionalsuperscript𝑒𝑐subscript𝑀𝑡subscriptsubscript𝑡1superscript𝑒𝛼subscript𝑀subscript𝑡1superscript𝛼2subscript𝑀subscript𝑡2superscript𝛼𝑆subscript𝑀subscript𝑡𝑆\displaystyle=\mathbb{E}\Big{\{}\mathbb{E}\big{[}e^{cM_{t}}|\mathcal{F}_{t_{1}% }\big{]}e^{\alpha M_{t_{1}}+\alpha^{2}M_{t_{2}}+\ldots+\alpha^{S}M_{t_{S}}}% \Big{\}}.= blackboard_E { blackboard_E [ italic_e start_POSTSUPERSCRIPT italic_c italic_M start_POSTSUBSCRIPT italic_t end_POSTSUBSCRIPT end_POSTSUPERSCRIPT | caligraphic_F start_POSTSUBSCRIPT italic_t start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT end_POSTSUBSCRIPT ] italic_e start_POSTSUPERSCRIPT italic_α italic_M start_POSTSUBSCRIPT italic_t start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT end_POSTSUBSCRIPT + italic_α start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT italic_M start_POSTSUBSCRIPT italic_t start_POSTSUBSCRIPT 2 end_POSTSUBSCRIPT end_POSTSUBSCRIPT + … + italic_α start_POSTSUPERSCRIPT italic_S end_POSTSUPERSCRIPT italic_M start_POSTSUBSCRIPT italic_t start_POSTSUBSCRIPT italic_S end_POSTSUBSCRIPT end_POSTSUBSCRIPT end_POSTSUPERSCRIPT } . (\arabicequation)

Analyzing the first term on the RHS of (\arabicequation), provided that c<1𝑐1c<1italic_c < 1,

𝔼[ecMt|t1]𝔼delimited-[]conditionalsuperscript𝑒𝑐subscript𝑀𝑡subscriptsubscript𝑡1\displaystyle\mathbb{E}\big{[}e^{cM_{t}}|\mathcal{F}_{t_{1}}\big{]}blackboard_E [ italic_e start_POSTSUPERSCRIPT italic_c italic_M start_POSTSUBSCRIPT italic_t end_POSTSUBSCRIPT end_POSTSUPERSCRIPT | caligraphic_F start_POSTSUBSCRIPT italic_t start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT end_POSTSUBSCRIPT ] =(i)i=1n𝔼ecξi,t𝑖superscriptsubscriptproduct𝑖1𝑛𝔼superscript𝑒𝑐subscript𝜉𝑖𝑡\displaystyle\overset{(i)}{=}\prod_{i=1}^{n}\mathbb{E}e^{c\xi_{i,t}}start_OVERACCENT ( italic_i ) end_OVERACCENT start_ARG = end_ARG ∏ start_POSTSUBSCRIPT italic_i = 1 end_POSTSUBSCRIPT start_POSTSUPERSCRIPT italic_n end_POSTSUPERSCRIPT blackboard_E italic_e start_POSTSUPERSCRIPT italic_c italic_ξ start_POSTSUBSCRIPT italic_i , italic_t end_POSTSUBSCRIPT end_POSTSUPERSCRIPT
=i=1n(1+c𝔼[ξi,t]+k=2𝔼[1k!ckξi,tk])absentsuperscriptsubscriptproduct𝑖1𝑛1𝑐𝔼delimited-[]subscript𝜉𝑖𝑡superscriptsubscript𝑘2𝔼delimited-[]1𝑘superscript𝑐𝑘subscriptsuperscript𝜉𝑘𝑖𝑡\displaystyle=\prod_{i=1}^{n}\Big{(}1+c\mathbb{E}\big{[}\xi_{i,t}\big{]}+\sum_% {k=2}^{\infty}\mathbb{E}\big{[}\frac{1}{k!}c^{k}\xi^{k}_{i,t}\big{]}\Big{)}= ∏ start_POSTSUBSCRIPT italic_i = 1 end_POSTSUBSCRIPT start_POSTSUPERSCRIPT italic_n end_POSTSUPERSCRIPT ( 1 + italic_c blackboard_E [ italic_ξ start_POSTSUBSCRIPT italic_i , italic_t end_POSTSUBSCRIPT ] + ∑ start_POSTSUBSCRIPT italic_k = 2 end_POSTSUBSCRIPT start_POSTSUPERSCRIPT ∞ end_POSTSUPERSCRIPT blackboard_E [ divide start_ARG 1 end_ARG start_ARG italic_k ! end_ARG italic_c start_POSTSUPERSCRIPT italic_k end_POSTSUPERSCRIPT italic_ξ start_POSTSUPERSCRIPT italic_k end_POSTSUPERSCRIPT start_POSTSUBSCRIPT italic_i , italic_t end_POSTSUBSCRIPT ] )
=(ii)i=1n(1+k=2ckβ)=i=1n(1+βc21c)(iii)exp(nβc21c).𝑖𝑖superscriptsubscriptproduct𝑖1𝑛1superscriptsubscript𝑘2superscript𝑐𝑘𝛽superscriptsubscriptproduct𝑖1𝑛1𝛽superscript𝑐21𝑐𝑖𝑖𝑖𝑛𝛽superscript𝑐21𝑐\displaystyle\overset{(ii)}{=}\prod_{i=1}^{n}\Big{(}1+\sum_{k=2}^{\infty}c^{k}% \beta\Big{)}=\prod_{i=1}^{n}\Big{(}1+\frac{\beta c^{2}}{1-c}\Big{)}\overset{(% iii)}{\leq}\exp\big{(}\frac{n\beta c^{2}}{1-c}\big{)}.start_OVERACCENT ( italic_i italic_i ) end_OVERACCENT start_ARG = end_ARG ∏ start_POSTSUBSCRIPT italic_i = 1 end_POSTSUBSCRIPT start_POSTSUPERSCRIPT italic_n end_POSTSUPERSCRIPT ( 1 + ∑ start_POSTSUBSCRIPT italic_k = 2 end_POSTSUBSCRIPT start_POSTSUPERSCRIPT ∞ end_POSTSUPERSCRIPT italic_c start_POSTSUPERSCRIPT italic_k end_POSTSUPERSCRIPT italic_β ) = ∏ start_POSTSUBSCRIPT italic_i = 1 end_POSTSUBSCRIPT start_POSTSUPERSCRIPT italic_n end_POSTSUPERSCRIPT ( 1 + divide start_ARG italic_β italic_c start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT end_ARG start_ARG 1 - italic_c end_ARG ) start_OVERACCENT ( italic_i italic_i italic_i ) end_OVERACCENT start_ARG ≤ end_ARG roman_exp ( divide start_ARG italic_n italic_β italic_c start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT end_ARG start_ARG 1 - italic_c end_ARG ) . (\arabicequation)

where (i)𝑖(i)( italic_i ) holds from (\arabicequation), (ii)𝑖𝑖(ii)( italic_i italic_i ) holds since 𝔼[ξi,t]=0𝔼delimited-[]subscript𝜉𝑖𝑡0\mathbb{E}[\xi_{i,t}]=0blackboard_E [ italic_ξ start_POSTSUBSCRIPT italic_i , italic_t end_POSTSUBSCRIPT ] = 0 and 𝔼[|ξi,t|k]β=γ/T𝔼delimited-[]superscriptsubscript𝜉𝑖𝑡𝑘𝛽𝛾𝑇\mathbb{E}[|\xi_{i,t}|^{k}]\leq\beta=\gamma/Tblackboard_E [ | italic_ξ start_POSTSUBSCRIPT italic_i , italic_t end_POSTSUBSCRIPT | start_POSTSUPERSCRIPT italic_k end_POSTSUPERSCRIPT ] ≤ italic_β = italic_γ / italic_T, and (iii)𝑖𝑖𝑖(iii)( italic_i italic_i italic_i ) holds since exp(x)1+x𝑥1𝑥\exp(x)\geq 1+xroman_exp ( italic_x ) ≥ 1 + italic_x. Combining (\arabicequation) with (\arabicequation), we obtain

𝔼[ecZt]𝔼delimited-[]superscript𝑒𝑐subscript𝑍𝑡\displaystyle\mathbb{E}\big{[}e^{cZ_{t}}\big{]}blackboard_E [ italic_e start_POSTSUPERSCRIPT italic_c italic_Z start_POSTSUBSCRIPT italic_t end_POSTSUBSCRIPT end_POSTSUPERSCRIPT ] enβc21c𝔼[ec(αMt1+α2Mt2++αSMtS)]absentsuperscript𝑒𝑛𝛽superscript𝑐21𝑐𝔼delimited-[]superscript𝑒𝑐𝛼subscript𝑀subscript𝑡1superscript𝛼2subscript𝑀subscript𝑡2superscript𝛼𝑆subscript𝑀subscript𝑡𝑆\displaystyle\leq e^{\frac{n\beta c^{2}}{1-c}}\cdot\mathbb{E}\big{[}e^{c(% \alpha M_{t_{1}}+\alpha^{2}M_{t_{2}}+\ldots+\alpha^{S}M_{t_{S}})}\big{]}≤ italic_e start_POSTSUPERSCRIPT divide start_ARG italic_n italic_β italic_c start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT end_ARG start_ARG 1 - italic_c end_ARG end_POSTSUPERSCRIPT ⋅ blackboard_E [ italic_e start_POSTSUPERSCRIPT italic_c ( italic_α italic_M start_POSTSUBSCRIPT italic_t start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT end_POSTSUBSCRIPT + italic_α start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT italic_M start_POSTSUBSCRIPT italic_t start_POSTSUBSCRIPT 2 end_POSTSUBSCRIPT end_POSTSUBSCRIPT + … + italic_α start_POSTSUPERSCRIPT italic_S end_POSTSUPERSCRIPT italic_M start_POSTSUBSCRIPT italic_t start_POSTSUBSCRIPT italic_S end_POSTSUBSCRIPT end_POSTSUBSCRIPT ) end_POSTSUPERSCRIPT ]
=(iv)enβc21c𝔼{𝔼[ecαMt1|t2]ec(α2Mt2++αSMtS)}𝑖𝑣superscript𝑒𝑛𝛽superscript𝑐21𝑐𝔼𝔼delimited-[]conditionalsuperscript𝑒𝑐𝛼subscript𝑀subscript𝑡1subscriptsubscript𝑡2superscript𝑒𝑐superscript𝛼2subscript𝑀subscript𝑡2superscript𝛼𝑆subscript𝑀subscript𝑡𝑆\displaystyle\overset{(iv)}{=}e^{\frac{n\beta c^{2}}{1-c}}\cdot\mathbb{E}\Big{% \{}\mathbb{E}\big{[}e^{c\alpha M_{t_{1}}}|\mathcal{F}_{t_{2}}\big{]}e^{c(% \alpha^{2}M_{t_{2}}+\ldots+\alpha^{S}M_{t_{S}})}\Big{\}}start_OVERACCENT ( italic_i italic_v ) end_OVERACCENT start_ARG = end_ARG italic_e start_POSTSUPERSCRIPT divide start_ARG italic_n italic_β italic_c start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT end_ARG start_ARG 1 - italic_c end_ARG end_POSTSUPERSCRIPT ⋅ blackboard_E { blackboard_E [ italic_e start_POSTSUPERSCRIPT italic_c italic_α italic_M start_POSTSUBSCRIPT italic_t start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT end_POSTSUBSCRIPT end_POSTSUPERSCRIPT | caligraphic_F start_POSTSUBSCRIPT italic_t start_POSTSUBSCRIPT 2 end_POSTSUBSCRIPT end_POSTSUBSCRIPT ] italic_e start_POSTSUPERSCRIPT italic_c ( italic_α start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT italic_M start_POSTSUBSCRIPT italic_t start_POSTSUBSCRIPT 2 end_POSTSUBSCRIPT end_POSTSUBSCRIPT + … + italic_α start_POSTSUPERSCRIPT italic_S end_POSTSUPERSCRIPT italic_M start_POSTSUBSCRIPT italic_t start_POSTSUBSCRIPT italic_S end_POSTSUBSCRIPT end_POSTSUBSCRIPT ) end_POSTSUPERSCRIPT }
(v)enβc21c𝔼{𝔼[ecMt1|t2]αec(α2Mt2++αSMtS)}𝑣superscript𝑒𝑛𝛽superscript𝑐21𝑐𝔼𝔼superscriptdelimited-[]conditionalsuperscript𝑒𝑐subscript𝑀subscript𝑡1subscriptsubscript𝑡2𝛼superscript𝑒𝑐superscript𝛼2subscript𝑀subscript𝑡2superscript𝛼𝑆subscript𝑀subscript𝑡𝑆\displaystyle\overset{(v)}{\leq}e^{\frac{n\beta c^{2}}{1-c}}\cdot\mathbb{E}% \Big{\{}\mathbb{E}\big{[}e^{cM_{t_{1}}}|\mathcal{F}_{t_{2}}\big{]}^{\alpha}e^{% c(\alpha^{2}M_{t_{2}}+\ldots+\alpha^{S}M_{t_{S}})}\Big{\}}start_OVERACCENT ( italic_v ) end_OVERACCENT start_ARG ≤ end_ARG italic_e start_POSTSUPERSCRIPT divide start_ARG italic_n italic_β italic_c start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT end_ARG start_ARG 1 - italic_c end_ARG end_POSTSUPERSCRIPT ⋅ blackboard_E { blackboard_E [ italic_e start_POSTSUPERSCRIPT italic_c italic_M start_POSTSUBSCRIPT italic_t start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT end_POSTSUBSCRIPT end_POSTSUPERSCRIPT | caligraphic_F start_POSTSUBSCRIPT italic_t start_POSTSUBSCRIPT 2 end_POSTSUBSCRIPT end_POSTSUBSCRIPT ] start_POSTSUPERSCRIPT italic_α end_POSTSUPERSCRIPT italic_e start_POSTSUPERSCRIPT italic_c ( italic_α start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT italic_M start_POSTSUBSCRIPT italic_t start_POSTSUBSCRIPT 2 end_POSTSUBSCRIPT end_POSTSUBSCRIPT + … + italic_α start_POSTSUPERSCRIPT italic_S end_POSTSUPERSCRIPT italic_M start_POSTSUBSCRIPT italic_t start_POSTSUBSCRIPT italic_S end_POSTSUBSCRIPT end_POSTSUBSCRIPT ) end_POSTSUPERSCRIPT }
(vi)enβc21c𝔼{(enβc21c)αec(α2Mt2++αSMtS)}𝑣𝑖superscript𝑒𝑛𝛽superscript𝑐21𝑐𝔼superscriptsuperscript𝑒𝑛𝛽superscript𝑐21𝑐𝛼superscript𝑒𝑐superscript𝛼2subscript𝑀subscript𝑡2superscript𝛼𝑆subscript𝑀subscript𝑡𝑆\displaystyle\overset{(vi)}{\leq}e^{\frac{n\beta c^{2}}{1-c}}\cdot\mathbb{E}% \Big{\{}\big{(}e^{\frac{n\beta c^{2}}{1-c}}\big{)}^{\alpha}e^{c(\alpha^{2}M_{t% _{2}}+\ldots+\alpha^{S}M_{t_{S}})}\Big{\}}start_OVERACCENT ( italic_v italic_i ) end_OVERACCENT start_ARG ≤ end_ARG italic_e start_POSTSUPERSCRIPT divide start_ARG italic_n italic_β italic_c start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT end_ARG start_ARG 1 - italic_c end_ARG end_POSTSUPERSCRIPT ⋅ blackboard_E { ( italic_e start_POSTSUPERSCRIPT divide start_ARG italic_n italic_β italic_c start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT end_ARG start_ARG 1 - italic_c end_ARG end_POSTSUPERSCRIPT ) start_POSTSUPERSCRIPT italic_α end_POSTSUPERSCRIPT italic_e start_POSTSUPERSCRIPT italic_c ( italic_α start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT italic_M start_POSTSUBSCRIPT italic_t start_POSTSUBSCRIPT 2 end_POSTSUBSCRIPT end_POSTSUBSCRIPT + … + italic_α start_POSTSUPERSCRIPT italic_S end_POSTSUPERSCRIPT italic_M start_POSTSUBSCRIPT italic_t start_POSTSUBSCRIPT italic_S end_POSTSUBSCRIPT end_POSTSUBSCRIPT ) end_POSTSUPERSCRIPT }
e(1+α)nβc21c𝔼{ec(α2Mt2++αSMtS)},absentsuperscript𝑒1𝛼𝑛𝛽superscript𝑐21𝑐𝔼superscript𝑒𝑐superscript𝛼2subscript𝑀subscript𝑡2superscript𝛼𝑆subscript𝑀subscript𝑡𝑆\displaystyle\leq e^{\frac{(1+\alpha)n\beta c^{2}}{1-c}}\cdot\mathbb{E}\Big{\{% }e^{c(\alpha^{2}M_{t_{2}}+\ldots+\alpha^{S}M_{t_{S}})}\Big{\}},≤ italic_e start_POSTSUPERSCRIPT divide start_ARG ( 1 + italic_α ) italic_n italic_β italic_c start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT end_ARG start_ARG 1 - italic_c end_ARG end_POSTSUPERSCRIPT ⋅ blackboard_E { italic_e start_POSTSUPERSCRIPT italic_c ( italic_α start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT italic_M start_POSTSUBSCRIPT italic_t start_POSTSUBSCRIPT 2 end_POSTSUBSCRIPT end_POSTSUBSCRIPT + … + italic_α start_POSTSUPERSCRIPT italic_S end_POSTSUPERSCRIPT italic_M start_POSTSUBSCRIPT italic_t start_POSTSUBSCRIPT italic_S end_POSTSUBSCRIPT end_POSTSUBSCRIPT ) end_POSTSUPERSCRIPT } , (\arabicequation)

where (iv)𝑖𝑣(iv)( italic_i italic_v ) holds by an argument analogous to (\arabicequation), (v)𝑣(v)( italic_v ) holds by Jensen’s inequality since f(x)=xα𝑓𝑥superscript𝑥𝛼f(x)=x^{\alpha}italic_f ( italic_x ) = italic_x start_POSTSUPERSCRIPT italic_α end_POSTSUPERSCRIPT is concave for α(0,1)𝛼01\alpha\in(0,1)italic_α ∈ ( 0 , 1 ), (vi)𝑣𝑖(vi)( italic_v italic_i ) holds by an argument analogous to (\arabicequation). Repeating the argument for (\arabicequation) a total for S𝑆Sitalic_S times (recalling that α(0,1)𝛼01\alpha\in(0,1)italic_α ∈ ( 0 , 1 )) yields our desired inequality

𝔼[ecZt]e(1+α+α2++αS)nβc21ceTnβc2(1c)𝔼delimited-[]superscript𝑒𝑐subscript𝑍𝑡superscript𝑒1𝛼superscript𝛼2superscript𝛼𝑆𝑛𝛽superscript𝑐21𝑐superscript𝑒𝑇𝑛𝛽superscript𝑐21𝑐\mathbb{E}\big{[}e^{cZ_{t}}\big{]}\leq e^{\frac{(1+\alpha+\alpha^{2}+\ldots+% \alpha^{S})n\beta c^{2}}{1-c}}\leq e^{\frac{Tn\beta c^{2}}{(1-c)}}blackboard_E [ italic_e start_POSTSUPERSCRIPT italic_c italic_Z start_POSTSUBSCRIPT italic_t end_POSTSUBSCRIPT end_POSTSUPERSCRIPT ] ≤ italic_e start_POSTSUPERSCRIPT divide start_ARG ( 1 + italic_α + italic_α start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT + … + italic_α start_POSTSUPERSCRIPT italic_S end_POSTSUPERSCRIPT ) italic_n italic_β italic_c start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT end_ARG start_ARG 1 - italic_c end_ARG end_POSTSUPERSCRIPT ≤ italic_e start_POSTSUPERSCRIPT divide start_ARG italic_T italic_n italic_β italic_c start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT end_ARG start_ARG ( 1 - italic_c ) end_ARG end_POSTSUPERSCRIPT (\arabicequation)

Returning to our original goal of constructing a tail bound for Ztsubscript𝑍𝑡Z_{t}italic_Z start_POSTSUBSCRIPT italic_t end_POSTSUBSCRIPT, we then use Markov’s inequality alongside (\arabicequation) to yield the inequalities that for any τ>0𝜏0\tau>0italic_τ > 0,

(Ztτ)(ecZtecτ)𝔼[ecZt]/ecτ(viii)exp(Tnβc21ccτ)subscript𝑍𝑡𝜏superscript𝑒𝑐subscript𝑍𝑡superscript𝑒𝑐𝜏𝔼delimited-[]superscript𝑒𝑐subscript𝑍𝑡superscript𝑒𝑐𝜏𝑣𝑖𝑖𝑖𝑇𝑛𝛽superscript𝑐21𝑐𝑐𝜏\mathbb{P}\big{(}Z_{t}\geq\tau\big{)}\leq\mathbb{P}\big{(}e^{cZ_{t}}\geq e^{c% \tau}\big{)}\leq\mathbb{E}\big{[}e^{cZ_{t}}\big{]}/e^{c\tau}\overset{(viii)}{% \leq}\exp\Big{(}\frac{Tn\beta c^{2}}{1-c}-c\tau\Big{)}blackboard_P ( italic_Z start_POSTSUBSCRIPT italic_t end_POSTSUBSCRIPT ≥ italic_τ ) ≤ blackboard_P ( italic_e start_POSTSUPERSCRIPT italic_c italic_Z start_POSTSUBSCRIPT italic_t end_POSTSUBSCRIPT end_POSTSUPERSCRIPT ≥ italic_e start_POSTSUPERSCRIPT italic_c italic_τ end_POSTSUPERSCRIPT ) ≤ blackboard_E [ italic_e start_POSTSUPERSCRIPT italic_c italic_Z start_POSTSUBSCRIPT italic_t end_POSTSUBSCRIPT end_POSTSUPERSCRIPT ] / italic_e start_POSTSUPERSCRIPT italic_c italic_τ end_POSTSUPERSCRIPT start_OVERACCENT ( italic_v italic_i italic_i italic_i ) end_OVERACCENT start_ARG ≤ end_ARG roman_exp ( divide start_ARG italic_T italic_n italic_β italic_c start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT end_ARG start_ARG 1 - italic_c end_ARG - italic_c italic_τ )

where (viii)𝑣𝑖𝑖𝑖(viii)( italic_v italic_i italic_i italic_i ) holds from (\arabicequation). Setting c=τ/(2Tnβ+τ)𝑐𝜏2𝑇𝑛𝛽𝜏c=\tau/(2Tn\beta+\tau)italic_c = italic_τ / ( 2 italic_T italic_n italic_β + italic_τ ) yields,

(Ztτ)exp(τ24Tnβ+2τ).subscript𝑍𝑡𝜏superscript𝜏24𝑇𝑛𝛽2𝜏\mathbb{P}\big{(}Z_{t}\geq\tau\big{)}\leq\exp\Big{(}\frac{-\tau^{2}}{4Tn\beta+% 2\tau}\Big{)}.blackboard_P ( italic_Z start_POSTSUBSCRIPT italic_t end_POSTSUBSCRIPT ≥ italic_τ ) ≤ roman_exp ( divide start_ARG - italic_τ start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT end_ARG start_ARG 4 italic_T italic_n italic_β + 2 italic_τ end_ARG ) .

By symmetry of Ztsubscript𝑍𝑡Z_{t}italic_Z start_POSTSUBSCRIPT italic_t end_POSTSUBSCRIPT around 0, we equally obtain an equivalent upper-bound for (Ztτ)subscript𝑍𝑡𝜏\mathbb{P}(-Z_{t}\geq\tau)blackboard_P ( - italic_Z start_POSTSUBSCRIPT italic_t end_POSTSUBSCRIPT ≥ italic_τ ). This combines to form our desired bound,

(|Zt|τ)2exp(τ24Tnβ+2τ).subscript𝑍𝑡𝜏2superscript𝜏24𝑇𝑛𝛽2𝜏\mathbb{P}\big{(}|Z_{t}|\geq\tau\big{)}\leq 2\exp\Big{(}\frac{-\tau^{2}}{4Tn% \beta+2\tau}\Big{)}.blackboard_P ( | italic_Z start_POSTSUBSCRIPT italic_t end_POSTSUBSCRIPT | ≥ italic_τ ) ≤ 2 roman_exp ( divide start_ARG - italic_τ start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT end_ARG start_ARG 4 italic_T italic_n italic_β + 2 italic_τ end_ARG ) .

Hence, by setting τ=cmax{Tnβlog(T),log(T)}𝜏normal-⋅superscript𝑐normal-′𝑇𝑛𝛽𝑇𝑇\tau=c^{\prime}\cdot\max\{\sqrt{Tn\beta\log(T)},\log(T)\}italic_τ = italic_c start_POSTSUPERSCRIPT ′ end_POSTSUPERSCRIPT ⋅ roman_max { square-root start_ARG italic_T italic_n italic_β roman_log ( italic_T ) end_ARG , roman_log ( italic_T ) } for a universal csuperscript𝑐normal-′c^{\prime}italic_c start_POSTSUPERSCRIPT ′ end_POSTSUPERSCRIPT, we have

(|Zt|τ)1T2.subscript𝑍𝑡𝜏1superscript𝑇2\mathbb{P}\big{(}|Z_{t}|\geq\tau\big{)}\leq\frac{1}{T^{2}}.blackboard_P ( | italic_Z start_POSTSUBSCRIPT italic_t end_POSTSUBSCRIPT | ≥ italic_τ ) ≤ divide start_ARG 1 end_ARG start_ARG italic_T start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT end_ARG .

Therefore, using a union bound, we are ensured with probability at least 11/T11𝑇1-1/T1 - 1 / italic_T, all {Zt}subscript𝑍𝑡\{Z_{t}\}{ italic_Z start_POSTSUBSCRIPT italic_t end_POSTSUBSCRIPT }’s are bounded by

cmax{Tnβlog(T),log(T)}=cmax{nγlog(T),log(T)}superscript𝑐𝑇𝑛𝛽𝑇𝑇superscript𝑐𝑛𝛾𝑇𝑇c^{\prime}\cdot\max\{\sqrt{Tn\beta\log(T)},\log(T)\}=c^{\prime}\cdot\max\{% \sqrt{n\gamma\log(T)},\log(T)\}italic_c start_POSTSUPERSCRIPT ′ end_POSTSUPERSCRIPT ⋅ roman_max { square-root start_ARG italic_T italic_n italic_β roman_log ( italic_T ) end_ARG , roman_log ( italic_T ) } = italic_c start_POSTSUPERSCRIPT ′ end_POSTSUPERSCRIPT ⋅ roman_max { square-root start_ARG italic_n italic_γ roman_log ( italic_T ) end_ARG , roman_log ( italic_T ) }

in magnitude simultaneously for all t𝒯𝑡𝒯t\in\mathcal{T}italic_t ∈ caligraphic_T.

Below, we upper-bound the probability the number of nodes that change membership across between any two consecutive timepoints is less than a particular threshold. The following lemma is different from Lemma .\arabictheorem for two main reasons: 1) Lemma .\arabictheorem handles the maximal difference between two membership matrices within a time interval, whereas the following lemma focuses on only two consecutive timepoints. 2) The following lemma will make an assumption about node’s behavior within a time interval of 1/T1𝑇1/T1 / italic_T that will simplify the proof.

Lemma .\arabictheorem.

Assume a two-community model (i.e., K=2𝐾2K=2italic_K = 2) following the model described in Section \arabicsection (using Assumption \arabicsection.\arabictheorem instead of Assumption \arabicsection.\arabicsubsection). Then, the probability that more than

5nγT+4log(T)5𝑛𝛾𝑇4𝑇\frac{5n\gamma}{T}+4\log(T)divide start_ARG 5 italic_n italic_γ end_ARG start_ARG italic_T end_ARG + 4 roman_log ( italic_T )

nodes change membership between any two (fixed) consecutive timepoints s,t𝒯𝑠𝑡𝒯s,t\in\mathcal{T}italic_s , italic_t ∈ caligraphic_T (i.e., ts=1/T𝑡𝑠1𝑇t-s=1/Titalic_t - italic_s = 1 / italic_T) is at most 1/T21superscript𝑇21/T^{2}1 / italic_T start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT.

Proof .\arabictheorem.

Consider the two events,

1subscript1\displaystyle\mathcal{E}_{1}caligraphic_E start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT ={nL(M(s),M(t))nγT+τ}absent𝑛𝐿superscript𝑀𝑠superscript𝑀𝑡𝑛𝛾𝑇𝜏\displaystyle=\Big{\{}n\cdot L(M^{(s)},M^{(t)})\geq n\cdot\frac{\gamma}{T}+% \tau\Big{\}}= { italic_n ⋅ italic_L ( italic_M start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT , italic_M start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ) ≥ italic_n ⋅ divide start_ARG italic_γ end_ARG start_ARG italic_T end_ARG + italic_τ }
2subscript2\displaystyle\mathcal{E}_{2}caligraphic_E start_POSTSUBSCRIPT 2 end_POSTSUBSCRIPT ={(# of nodes that change communities anytime between s and t)nγT+τ},absent# of nodes that change communities anytime between s and t𝑛𝛾𝑇𝜏\displaystyle=\Big{\{}(\#\text{ of nodes that change communities anytime % between $s$ and $t$})\geq n\cdot\frac{\gamma}{T}+\tau\Big{\}},= { ( # of nodes that change communities anytime between italic_s and italic_t ) ≥ italic_n ⋅ divide start_ARG italic_γ end_ARG start_ARG italic_T end_ARG + italic_τ } ,

where, recall, nL(M(s),M(t))normal-⋅𝑛𝐿superscript𝑀𝑠superscript𝑀𝑡n\cdot L(M^{(s)},M^{(t)})italic_n ⋅ italic_L ( italic_M start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT , italic_M start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ) is the number of nodes that change communities when comparing time s𝑠sitalic_s to time t𝑡titalic_t. We are interested in bounding (1)subscript1(\mathcal{E}_{1})( caligraphic_E start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT ) for an appropriately chosen τ𝜏\tauitalic_τ. However, observe that 12normal-⇒subscript1subscript2\mathcal{E}_{1}\Rightarrow\mathcal{E}_{2}caligraphic_E start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT ⇒ caligraphic_E start_POSTSUBSCRIPT 2 end_POSTSUBSCRIPT, hence (1)(2)subscript1subscript2\mathbb{P}(\mathcal{E}_{1})\leq\mathbb{P}(\mathcal{E}_{2})blackboard_P ( caligraphic_E start_POSTSUBSCRIPT 1 end_POSTSUBSCRIPT ) ≤ blackboard_P ( caligraphic_E start_POSTSUBSCRIPT 2 end_POSTSUBSCRIPT ). Therefore, we are interested in bounding (2)subscript2\mathbb{P}(\mathcal{E}_{2})blackboard_P ( caligraphic_E start_POSTSUBSCRIPT 2 end_POSTSUBSCRIPT ).

By Assumption \arabicsection.\arabictheorem, each node changes memberships within a time interval of length 1/T1𝑇1/T1 / italic_T independently of one another at rate γ/T𝛾𝑇\gamma/Titalic_γ / italic_T. Hence,

(2)=(XnγT+τ).subscript2𝑋𝑛𝛾𝑇𝜏\mathbb{P}(\mathcal{E}_{2})=\mathbb{P}\Big{(}X\geq n\cdot\frac{\gamma}{T}+\tau% \Big{)}.blackboard_P ( caligraphic_E start_POSTSUBSCRIPT 2 end_POSTSUBSCRIPT ) = blackboard_P ( italic_X ≥ italic_n ⋅ divide start_ARG italic_γ end_ARG start_ARG italic_T end_ARG + italic_τ ) . (\arabicequation)

Since there are only two communities and we assume that if nodes that change memberships deterministically do not return to the original membership within a time interval of 1/T1𝑇1/T1 / italic_T, the 𝐵𝑒𝑟𝑛𝑜𝑢𝑙𝑙𝑖(γ/T)𝐵𝑒𝑟𝑛𝑜𝑢𝑙𝑙𝑖𝛾𝑇\text{Bernoulli}(\gamma/T)Bernoulli ( italic_γ / italic_T ) process of node membership changes in Assumption \arabicsection.\arabictheorem allows us to model X𝑋Xitalic_X as a Bernoulli random variable with mean nγ/T𝑛𝛾𝑇n\gamma/Titalic_n italic_γ / italic_T.

Therefore, to upper-bound the RHS of (\arabicequation), we use Bernstein’s inequality (for example, Lemma 4.1.9 from De la Pena & Giné (2012)):

(XnγT+τ)exp(12τ2nγ/T+13τ).𝑋𝑛𝛾𝑇𝜏12superscript𝜏2𝑛𝛾𝑇13𝜏\mathbb{P}\Big{(}X\geq n\cdot\frac{\gamma}{T}+\tau\Big{)}\leq\exp\Big{(}\frac{% -\frac{1}{2}\tau^{2}}{n\gamma/T+\frac{1}{3}\tau}\Big{)}.blackboard_P ( italic_X ≥ italic_n ⋅ divide start_ARG italic_γ end_ARG start_ARG italic_T end_ARG + italic_τ ) ≤ roman_exp ( divide start_ARG - divide start_ARG 1 end_ARG start_ARG 2 end_ARG italic_τ start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT end_ARG start_ARG italic_n italic_γ / italic_T + divide start_ARG 1 end_ARG start_ARG 3 end_ARG italic_τ end_ARG ) . (\arabicequation)

Consider τ=4nγ/T+4log(T)𝜏4𝑛𝛾𝑇4𝑇\tau=4n\gamma/T+4\log(T)italic_τ = 4 italic_n italic_γ / italic_T + 4 roman_log ( italic_T ). If log(T)>nγ/T𝑇𝑛𝛾𝑇\log(T)>n\gamma/Troman_log ( italic_T ) > italic_n italic_γ / italic_T, then we have from (\arabicequation) that

(XnγT+τ)exp(16log2(T)91/3log(T))1/T2.𝑋𝑛𝛾𝑇𝜏16superscript2𝑇913𝑇1superscript𝑇2\mathbb{P}\Big{(}X\geq n\cdot\frac{\gamma}{T}+\tau\Big{)}\leq\exp\Big{(}\frac{% -16\log^{2}(T)}{9\cdot 1/3\cdot\log(T)}\Big{)}\leq 1/T^{2}.blackboard_P ( italic_X ≥ italic_n ⋅ divide start_ARG italic_γ end_ARG start_ARG italic_T end_ARG + italic_τ ) ≤ roman_exp ( divide start_ARG - 16 roman_log start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT ( italic_T ) end_ARG start_ARG 9 ⋅ 1 / 3 ⋅ roman_log ( italic_T ) end_ARG ) ≤ 1 / italic_T start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT .

Otherwise, if nγ/T>log(T)𝑛𝛾𝑇𝑇n\gamma/T>\log(T)italic_n italic_γ / italic_T > roman_log ( italic_T ), then we have from (\arabicequation) that

(XnγT+τ)exp(16(nγ/T)2(1+8/3)nγ/T)exp(2nγ/T)exp(2log(n))1/T2.𝑋𝑛𝛾𝑇𝜏16superscript𝑛𝛾𝑇2183𝑛𝛾𝑇2𝑛𝛾𝑇2𝑛1superscript𝑇2\mathbb{P}\Big{(}X\geq n\cdot\frac{\gamma}{T}+\tau\Big{)}\leq\exp\Big{(}\frac{% -16(n\gamma/T)^{2}}{(1+8/3)\cdot n\gamma/T}\Big{)}\leq\exp\big{(}-2n\gamma/T% \big{)}\leq\exp\big{(}-2\log(n)\big{)}\leq 1/T^{2}.blackboard_P ( italic_X ≥ italic_n ⋅ divide start_ARG italic_γ end_ARG start_ARG italic_T end_ARG + italic_τ ) ≤ roman_exp ( divide start_ARG - 16 ( italic_n italic_γ / italic_T ) start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT end_ARG start_ARG ( 1 + 8 / 3 ) ⋅ italic_n italic_γ / italic_T end_ARG ) ≤ roman_exp ( - 2 italic_n italic_γ / italic_T ) ≤ roman_exp ( - 2 roman_log ( italic_n ) ) ≤ 1 / italic_T start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT .

Putting everything together, we have shown that

(nL(M(s),M(t))5nγT+4log(T))1/T2,𝑛𝐿superscript𝑀𝑠superscript𝑀𝑡5𝑛𝛾𝑇4𝑇1superscript𝑇2\mathbb{P}\Big{(}n\cdot L(M^{(s)},M^{(t)})\geq 5n\cdot\frac{\gamma}{T}+4\log(T% )\Big{)}\leq 1/T^{2},blackboard_P ( italic_n ⋅ italic_L ( italic_M start_POSTSUPERSCRIPT ( italic_s ) end_POSTSUPERSCRIPT , italic_M start_POSTSUPERSCRIPT ( italic_t ) end_POSTSUPERSCRIPT ) ≥ 5 italic_n ⋅ divide start_ARG italic_γ end_ARG start_ARG italic_T end_ARG + 4 roman_log ( italic_T ) ) ≤ 1 / italic_T start_POSTSUPERSCRIPT 2 end_POSTSUPERSCRIPT ,

and hence we are done.

Appendix A Additional details and plots of networks

In this section, we provide preprocessing details and additional plots to display the results across all twelve networks.

A.\arabicsubsection Preprocessing of networks

The preprocessing consists of different steps: 1) preprocessing the scRNA-seq data via SAVER, 2) ordering the cells via pseudotime, and 3) constructing the twelve networks.

  • Preprocessing the scRNA-seq data via SAVER: Using the data from Trevino et al. (2021), we first extract the cells labeled In Glun trajectory as well as in cell types c8, c14, c2, c9, c5, and c7, as labeled by the authors. Additionally, we select genes that are marker genes for our selected cell types, as well as the differentially expressed genes between glutamatergic neurons between 16 postconceptional weeks and 20-24 postconceptional weeks, both sets also labeled by the authors.

    Using these selected cells and genes, we apply SAVER (Huang et al., 2018) to denoise the data using the default settings. We use this method over other existing denoising methods for scRNA-seq data since SAVER has been shown to experimentally validate and meaningfully retain correlations among genes.

  • Ordering the cells via pseudotime: To construct the pseudotime, we analyze the data based on the leading 10 principal components (after applying Seurat::NormalizeData, Seurat::FindVariableFeatures, Seurat::ScaleData, and Seurat::RunPCA). We then apply Slingshot (Street et al., 2018) to the cells in this PCA embedding, based on ordering the cell types: c8, followed by c14, followed by c2, followed by c9 and c5, and finally followed by c7. (The authors provided this order.) This provides the appropriate ordering of the 18,160 cells.

  • Constructing the twelve networks: We now have the SAVER-denoised scRNA-seq data and the appropriate ordering of cells. Based on this ordering, we partition the 18,160 cells into 12 equally-sized bins. For each bin, we compute the correlation matrix among all the genes and convert this matrix into an adjacency matrix based on whether or not the correlation is above 0.75 in magnitude. Finally, once we have completed this for all twelve networks, we remove any genes whose median degree (across all twelve networks) is 0 or 1. This results in the twelve networks we analyze among the 993 genes.

A.\arabicsubsection Additional plots of results for develo** brain

In the following, we provide additional plots across all twelve networks regarding the communities within each network and how the gene memberships in one network relate to other networks.

In Figure \arabicfigure, we plot the gene memberships for each network, where the graphical layout is held fixed. We can visually observe that specific genes change memberships over time, but most genes do not often change memberships.

Refer to caption
Figure \arabicfigure: Gene memberships across all twelve networks, where the graphical layout is fixed, and the gray lines denote edges between two correlated genes. Each gene is colored one of ten different colors (community 1 as burgundy, community 2 as red, community 3 as salmon, community 4 as orange, community 5 as lime, community 6 as olive, community 7 as purple, community 8 as purple, community 9 as blue, and community 10 as white).

In Figure \arabicfigure, we plot each of the twelve networks as adjacency matrices (i.e., heatmaps), where the genes are reshuffled from in rows/columns from one plot to the next so that genes in each community are grouped together. We can see an obvious membership structure within each network and slightly varying community sizes across time.

Refer to caption
Figure \arabicfigure: Adjacency matrices for each of the twelve networks, where the genes are reshuffled in rows/columns from one plot to the next so that genes in each community are grouped together. The yellow color denotes an edge between two genes, while dark blue denotes the absence of an edge. The communities are separated visually by a white dotted line. The colors for each community are the same as in \arabicfigure.

In Figure \arabicfigure, we plot the connectivity within and across communities, which better summarizes the adjacency matrices shown in Figure \arabicfigure. Based on Sylvester’s criterion, we can see that some of the twelve networks are indefinite (i.e., contain negative eigenvalues) based on 2-by-2 submatrices along the diagonal that have negative eigenvalues.

Refer to caption
Figure \arabicfigure: Connectivity matrices as heatmaps for each of the twelve networks. The shown numbers denote the percentage of edges within or across communities (among all possible edges), and the colors range from white (i.e., connectivity of 0) to bright red (i.e., connectivity of 1). The colors for each community are the same as in \arabicfigure.

Lastly, in Figure \arabicfigure, we plot the alluvial plots demonstrating how the membership structure changes from one network to the next and how the 10-dimensional embedding is appropriate to reveal the community structure within each network. This is an extended version of Figure \arabicfigure in the main text.

Refer to caption
Figure \arabicfigure: Alluvial plots across all twelve networks. This is an extension of the main text’s Figure \arabicfigure. The colors for each community are the same as in \arabicfigure.
\printhistory